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"]
}](_images/graphviz-78cea0bf666c089c27e21993e96a6b62017909cd.png)
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"]
}](_images/graphviz-504c0237e7344abd277e8a4bb31c2be0caa1c69c.png)
Subclassed by cxxopts::values::standard_value< T >
Public Functions
-
inline abstract_value()
-
inline abstract_value(const abstract_value &rhs)
-
inline virtual bool has_default() const override
-
inline virtual bool has_implicit() const override
-
inline virtual bool is_boolean() const override
-
inline virtual bool is_container() const override
-
abstract_value &operator=(const abstract_value&) = default
-
inline virtual void parse() const override
-
~abstract_value() override = default
Private Types
-
using Self = abstract_value<T>
-
inline abstract_value()
-
class AccelFunc
- #include <BiorthBasis.H>
Inheritence diagram for BasisClasses::AccelFunc:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"1" [label="BasisClasses::AccelFunc" tooltip="BasisClasses::AccelFunc" fillcolor="#BFBFBF"]
"2" [label="BasisClasses::AllTimeAccel" tooltip="BasisClasses::AllTimeAccel"]
"3" [label="BasisClasses::SingleTimeAccel" tooltip="BasisClasses::SingleTimeAccel"]
"2" -> "1" [dir=forward tooltip="public-inheritance"]
"3" -> "1" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-997e2cc4310d762b16af472f3308b52a595420ca.png)
Acceleration function class.
Subclassed by BasisClasses::AllTimeAccel, BasisClasses::SingleTimeAccel
Public Functions
-
inline AccelFunc()
Constructor.
-
virtual void evalcoefs(double t, BasisCoef mod) = 0
This evaluates the coefficients at time t. This is the member that is implemented in derived classes. It is more naturally a protected member in C++, but that makes deriving a class in Python more difficult.
-
inline Eigen::MatrixXd &F(double t, Eigen::MatrixXd &ps, Eigen::MatrixXd &accel, BasisCoef mod)
This computes and return the acceleration array.
-
inline virtual ~AccelFunc()
Destructor.
-
inline AccelFunc()
-
class AddSpheres
- #include <AddSpheres.H>
-
class AllTimeAccel : public BasisClasses::AccelFunc
- #include <BiorthBasis.H>
Inheritence diagram for BasisClasses::AllTimeAccel:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="BasisClasses::AccelFunc" tooltip="BasisClasses::AccelFunc"]
"1" [label="BasisClasses::AllTimeAccel" tooltip="BasisClasses::AllTimeAccel" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-004c9a7f9b0226d0d838345873e7ec0fd1fd9eaa.png)
Collaboration diagram for BasisClasses::AllTimeAccel:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="BasisClasses::AccelFunc" tooltip="BasisClasses::AccelFunc"]
"1" [label="BasisClasses::AllTimeAccel" tooltip="BasisClasses::AllTimeAccel" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-004c9a7f9b0226d0d838345873e7ec0fd1fd9eaa.png)
Evaluate acceleration for one component, return acceleration.
-
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"]
}](_images/graphviz-8496505c9c27206ba045e41e40cd544ae9dc413e.png)
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"]
}](_images/graphviz-8496505c9c27206ba045e41e40cd544ae9dc413e.png)
-
template<typename T = double>
class AsciiHisto - #include <AsciiHisto.H>
Process a std::vector into an ASCII histogram.
-
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"]
}](_images/graphviz-05a1b2de5f545858920921e93dec3776852da47a.png)
Axisymmetric disk density function for deprojection.
Subclassed by DoubleExponential, Exponential, FEED, Ferrers, MNdisk, PyModel, Truncated, diskbulge
-
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"]
}](_images/graphviz-8f8287c711f5bc62e8df1624617df98534d95d01.png)
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"]
}](_images/graphviz-4e44aadbb8196164a394d2a0db8761c26a92b62b.png)
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
-
inline int get_dof(void)
-
virtual double potl(const int, const int, const double) = 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
-
inline AxiSymBiorth(int DOF = 0)
-
class AxisymmetricBasis : public Basis
- #include <AxisymmetricBasis.H>
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"]
}](_images/graphviz-d471fcc87674273fbd0bf81de9f6f972053599a9.png)
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"]
}](_images/graphviz-0df55803a56cb0c55185f548d92c12eeb16a861b.png)
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
-
enumerator Hall
Public Functions
-
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)
-
virtual ~AxisymmetricBasis()
Destructor.
Protected Types
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.
Protected Attributes
-
unsigned defSampT
-
double hexp
Hall smoothing exponent (default: 1.0)
-
int Lmax
Maximum angular harmonic.
-
int Mmax
-
double muse
Accumulated mass for variance computation.
-
int nmax
Maximum radial basis index.
-
int npca
Frequency of PCA computation.
-
int npca0
First step for PCA computation.
-
bool pcaeof
Compute eof decomposition.
-
bool pcavar
Use principal component bootstrap analysis of variance to select coefficients
-
unsigned sampT
-
double snr
Signal-to-noise scaling parameter (default: 1.0)
-
bool subsamp
Partitioned variance computation.
-
unsigned vtkfreq
VTK diagnostic frequency.
Protected Static Attributes
-
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"]
}](_images/graphviz-9c7a46ce6ae83fc41ee7315ed01cd9a58a00e322.png)
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"]
}](_images/graphviz-24a5452f1c678cfdf6dbe2ddd4b3519d0ead2557.png)
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 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(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, 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.
-
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 Functions
Protected Attributes
-
double dEgrid
-
double dKgrid
-
vector<double> Egrid
-
vector<double> EgridMass
-
double Emax_grid
-
double Emin_grid
-
double gen_ecut
-
bool gen_firstime
-
bool gen_firstime_E
-
bool gen_firstime_jeans
-
double gen_fomax
-
double gen_lastr = -1.0
-
SphericalOrbit gen_orb
-
vector<double> Jmax
-
vector<double> Kgrid
-
inline AxiSymModel(void)
-
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"]
}](_images/graphviz-33d249220a02dd5d9185d030c40ea4c69dfa35d6.png)
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"]
}](_images/graphviz-33d249220a02dd5d9185d030c40ea4c69dfa35d6.png)
Handle bad range related exception PartMap.
-
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"]
}](_images/graphviz-56fb44335a7c20d38982ad52d21545edaf0ae343.png)
Public Functions
-
BarrierWrapper(const BarrierWrapper &inst)
Copy constructor.
-
BarrierWrapper(MPI_Comm comm, bool label = false)
Constructor.
-
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 Functions
-
void heavy_operator(const string &label, const char *file, const int line)
-
void light_operator(const string &label, const char *file, const int line)
Private Members
-
char *buffer
-
char *bufferT
-
bool check_label
-
MPI_Comm comm
-
int commsize
-
int localid
-
unsigned nrecv
-
bool onoff
-
unsigned queued
Private Static Attributes
-
static bool light
Friends
- friend class Info
-
BarrierWrapper(const BarrierWrapper &inst)
-
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"]
}](_images/graphviz-693e6bf83b9e53da9df7b73aca3c325b1842bba8.png)
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"]
}](_images/graphviz-6771f1b57d4a0af08f9079fdb8217cb93245af55.png)
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.
Public Functions
-
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
-
void legendre_R(int lmax, double x, Eigen::MatrixXd &p)
-
class Basis
- #include <BasisFactory.H>
Inheritence diagram for BasisClasses::Basis:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"1" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis" fillcolor="#BFBFBF"]
"9" [label="BasisClasses::Bessel" tooltip="BasisClasses::Bessel"]
"2" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis"]
"3" [label="BasisClasses::CBDisk" tooltip="BasisClasses::CBDisk"]
"4" [label="BasisClasses::Cube" tooltip="BasisClasses::Cube"]
"5" [label="BasisClasses::Cylindrical" tooltip="BasisClasses::Cylindrical"]
"11" [label="BasisClasses::FieldBasis" tooltip="BasisClasses::FieldBasis"]
"6" [label="BasisClasses::FlatDisk" tooltip="BasisClasses::FlatDisk"]
"7" [label="BasisClasses::Slab" tooltip="BasisClasses::Slab"]
"8" [label="BasisClasses::Spherical" tooltip="BasisClasses::Spherical"]
"10" [label="BasisClasses::SphericalSL" tooltip="BasisClasses::SphericalSL"]
"12" [label="BasisClasses::VelocityBasis" tooltip="BasisClasses::VelocityBasis"]
"9" -> "8" [dir=forward tooltip="public-inheritance"]
"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"]
"11" -> "1" [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" -> "8" [dir=forward tooltip="public-inheritance"]
"12" -> "11" [dir=forward tooltip="public-inheritance"]
"12" -> "1" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-aa1fbd11bd732a65ee73285e218f86f22df1c8b1.png)
Defines a basis-based.
Abstract class for any type of basis for evaluating a general phase-space function
Provides a factory member that returns derived class instances.
Subclassed by BasisClasses::BiorthBasis, BasisClasses::FieldBasis, BasisClasses::VelocityBasis
Public Functions
-
virtual void accumulate(double mass, double x, double y, double z, double u, double v, double w) = 0
Accumulate new coefficients from full phase space.
-
virtual void accumulate(double x, double y, double z, double mass) = 0
Accumulate new coefficients from coordinates only.
-
virtual void addFromArray(Eigen::VectorXd &m, RowMatrixXd &p, bool roundrobin, bool posvelrows) = 0
Accumulate coefficient contributions from arrays.
-
inline void clrSelector()
Clear the particle selector callback.
-
CoefClasses::CoefStrPtr createFromArray(Eigen::VectorXd &m, RowMatrixXd &p, double time = 0.0, std::vector<double> center = {0.0, 0.0, 0.0}, bool roundrobin = true, bool posvelrows = false)
Generate coeffients from an array and optional center location for the expansion
-
virtual CoefClasses::CoefStrPtr createFromReader(PR::PRptr reader, std::vector<double> ctr) = 0
Generate coeffients from a particle reader.
-
inline virtual std::tuple<std::vector<double>, std::vector<std::string>> evaluate(double x, double y, double z)
Evaluate fields at a point, and provide field lables.
-
inline virtual CoefClasses::CoefStrPtr getCoefficients()
Retrieve the coefficients.
Evaluate fields at a point for all coefficients sets.
-
inline double getMass(void)
Get mass on grid.
-
virtual void initFromArray(std::vector<double> ctr) = 0
Generate coefficients from a phase-space table.
-
virtual void make_coefs(void) = 0
Make coefficients after accumulation.
-
CoefClasses::CoefStrPtr makeFromArray(double time = 0.0)
Create and the coefficients from the array accumulation with the provided time value
-
virtual std::vector<double> operator()(double x1, double x2, double x3, const Coord ctype = Coord::Spherical)
Evaluate basis in desired coordinates.
-
virtual void reset_coefs(void) = 0
Zero out coefficients to prepare for a new expansion.
-
virtual void set_coefs(CoefClasses::CoefStrPtr coefs) = 0
Provide a set of coefficients using a CoefStruct.
-
inline void setColumnHeight(double value)
Height above/below the plane for midplane search in disk scale lengths
-
inline void setInertial()
Reset to inertial coordinates.
-
inline void setMidplane(bool value)
Turn on/off midplane evaluation (only effective for disk basis)
-
void setNonInertial(int Naccel, const Eigen::VectorXd &x, const Eigen::MatrixXd &pos)
Initialize non-inertial forces.
-
inline void setNonInertialAccel(double time)
Set the current pseudo acceleration.
-
inline bool usingNonInertial()
Returns true if non-inertial forces are active.
-
inline virtual ~Basis(void)
Destructor.
Public Static Functions
Protected Types
Protected Functions
-
virtual std::vector<double> crt_eval(double x, double y, double z) = 0
Evaluate fields in Cartesian coordinates in centered coordinate system.
-
virtual std::vector<double> cyl_eval(double r, double costh, double phi) = 0
Evaluate fields in cylindrical coordinates in centered coordinate system.
-
virtual void load_coefs(CoefClasses::CoefStrPtr coefs, double time) = 0
Load coefficients into the new CoefStruct.
Protected Attributes
-
unsigned long coefindx
Current particle index.
-
CoefClasses::CoefStrPtr coefret
Return instance for coefficients created from arrays.
-
double colh = 4.0
Midplane escursion parameter.
-
YAML::Node conf
-
bool midplane = false
Turn on midplane evaluation.
-
int Naccel = 0
Number of center points in acceleration estimator.
-
YAML::Node node
Contains contructor and BFE parameter database.
-
double totalMass
Total mass on grid.
-
bool use_mpi
Using MPI.
Protected Static Attributes
Private Functions
-
void initialize()
Helper for constructor.
Private Static Functions
Friends
- friend class Field::FieldGenerator
-
virtual void accumulate(double mass, double x, double y, double z, double u, double v, double w) = 0
-
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
Public Static Attributes
-
static bool debug
Enable orthgonality check.
-
virtual double dens(int M, int N, double r) = 0
-
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 getNorm(int m)
Get the norm for radial order m.
Private Functions
-
inline Bess(double order, unsigned int nroots)
-
class Bessel : public BasisClasses::Spherical
- #include <BiorthBasis.H>
Inheritence diagram for BasisClasses::Bessel:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"4" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"1" [label="BasisClasses::Bessel" tooltip="BasisClasses::Bessel" fillcolor="#BFBFBF"]
"3" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis"]
"2" [label="BasisClasses::Spherical" tooltip="BasisClasses::Spherical"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
"3" -> "4" [dir=forward tooltip="public-inheritance"]
"2" -> "3" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-2a9333bdf892988dbf6517947fe1ce6b54ae648b.png)
Collaboration diagram for BasisClasses::Bessel:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"4" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"1" [label="BasisClasses::Bessel" tooltip="BasisClasses::Bessel" fillcolor="#BFBFBF"]
"3" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis"]
"2" [label="BasisClasses::Spherical" tooltip="BasisClasses::Spherical"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
"3" -> "4" [dir=forward tooltip="public-inheritance"]
"2" -> "3" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-2a9333bdf892988dbf6517947fe1ce6b54ae648b.png)
Uses Bessel basis to evaluate expansion coeffients and provide potential and density basis fields
Public Functions
-
Bessel(const YAML::Node &conf)
Constructor from YAML node.
-
inline virtual std::vector<Eigen::MatrixXd> orthoCheck(int knots = 40)
Compute the orthogonality of the basis by returning inner produce matrices
-
inline virtual ~Bessel(void)
Destructor.
Protected Functions
-
void initialize()
Helper for constructor.
Protected Attributes
-
std::shared_ptr<BiorthBess> bess
Biorthgonal Bessel function generator.
-
Bessel(const YAML::Node &conf)
-
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"]
}](_images/graphviz-87f7f8ebeb115d3f6e6a29b84211e0ff05efd06d.png)
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"]
"14" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"13" [label="CoefClasses::SphCoefs" tooltip="CoefClasses::SphCoefs"]
"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"]
"13" -> "14" [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"]
"2" -> "13" [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"]
}](_images/graphviz-1e929399049563343ab30503469ae3c648ce9e2b.png)
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)
-
Bessel(Component *c0, const YAML::Node &conf, MixtureBasis *m = 0)
-
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"]
}](_images/graphviz-c57c5a31d146689dfc1e0c55f32e5ebc9037732d.png)
Subclassed by AxiSymBiorth, OneDBiorth
-
class BiorthBasis : public BasisClasses::Basis
- #include <BiorthBasis.H>
Inheritence diagram for BasisClasses::BiorthBasis:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"9" [label="BasisClasses::Bessel" tooltip="BasisClasses::Bessel"]
"1" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis" fillcolor="#BFBFBF"]
"3" [label="BasisClasses::CBDisk" tooltip="BasisClasses::CBDisk"]
"4" [label="BasisClasses::Cube" tooltip="BasisClasses::Cube"]
"5" [label="BasisClasses::Cylindrical" tooltip="BasisClasses::Cylindrical"]
"6" [label="BasisClasses::FlatDisk" tooltip="BasisClasses::FlatDisk"]
"7" [label="BasisClasses::Slab" tooltip="BasisClasses::Slab"]
"8" [label="BasisClasses::Spherical" tooltip="BasisClasses::Spherical"]
"10" [label="BasisClasses::SphericalSL" tooltip="BasisClasses::SphericalSL"]
"9" -> "8" [dir=forward tooltip="public-inheritance"]
"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"]
"10" -> "8" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-3270df913db7a77e12aa223dfb73fa215cced7ea.png)
Collaboration diagram for BasisClasses::BiorthBasis:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"1" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-fb70c5a3973686a93dd0523d5bcecc23a70155eb.png)
Defines a basis-based.
Abstract class for any type of basis for evaluating density, potential and acceleration.
Provides a factory member that returns derived class instances.
Subclassed by BasisClasses::CBDisk, BasisClasses::Cube, BasisClasses::Cylindrical, BasisClasses::FlatDisk, BasisClasses::Slab, BasisClasses::Spherical
Utility functions
-
void sinecosine_R(int mmax, double phi, Eigen::VectorXd &c, Eigen::VectorXd &s)
Compute vectors of sines and cosines by recursion.
-
virtual std::vector<double> sph_eval(double r, double costh, double phi) = 0
Evaluate fields in spherical coordinates in centered coordinate system.
-
virtual std::vector<double> cyl_eval(double r, double costh, double phi) = 0
Evaluate fields in cylindrical coordinates in centered coordinate system.
-
virtual std::vector<double> crt_eval(double x, double y, double z) = 0
Evaluate fields in Cartesian coordinates in centered coordinate system.
-
virtual void load_coefs(CoefClasses::CoefStrPtr coefs, double time) = 0
Load coefficients into the new CoefStruct.
-
inline BiorthBasis(const YAML::Node &conf, const std::string &name = "BiorthBasis")
Constructor from YAML node.
-
inline BiorthBasis(const std::string &confstr, const std::string &name = "BiorthBasis")
Constructor from YAML string.
-
inline virtual ~BiorthBasis(void)
Destructor.
-
virtual CoefClasses::CoefStrPtr createFromReader(PR::PRptr reader, std::vector<double> center = {0.0, 0.0, 0.0})
Generate coeffients from a particle reader and optional center location for the expansion
-
CoefClasses::CoefStrPtr createFromArray(Eigen::VectorXd &m, RowMatrixXd &p, double time = 0.0, std::vector<double> center = {0.0, 0.0, 0.0}, bool roundrobin = true, bool posvelrows = false)
Generate coeffients from an array and optional center location for the expansion
-
virtual void initFromArray(std::vector<double> center = {0.0, 0.0, 0.0})
Generate coeffients from an array and optional center location for the expansion using multiple particle partitions Initialize accumulating coefficients from arrays with an optional center vector. This is called once to initialize the accumulation.
-
virtual void addFromArray(Eigen::VectorXd &m, RowMatrixXd &p, bool roundrobin = true, bool posvelrows = false)
Initialize accumulating coefficients from arrays. This is called once to initialize the accumulation.
-
CoefClasses::CoefStrPtr makeFromArray(double time = 0.0)
Create and the coefficients from the array accumulation with the provided time value
-
virtual void accumulate(double x, double y, double z, double mass) = 0
Accumulate new coefficients.
-
inline virtual void accumulate(double mass, double x, double y, double z, double u, double v, double w)
Accumulate new coefficients.
-
inline double getMass(void)
Get mass on grid.
-
virtual void reset_coefs(void) = 0
Zero out coefficients to prepare for a new expansion.
-
virtual void make_coefs(void) = 0
Make coefficients after accumulation.
-
virtual void set_coefs(CoefClasses::CoefStrPtr coefs) = 0
Provide a set of coefficients using a CoefStruct.
-
inline void setSelector(const Callback &f)
Set the particle selector callback.
The coefficient factory. Creates a shared pointer to derived instance of the desired type and returns it.
-
inline void clrSelector()
Clear the particle selector callback.
Friends
- friend class Field::FieldGenerator
-
void sinecosine_R(int mmax, double phi, Eigen::VectorXd &c, Eigen::VectorXd &s)
-
class BiorthBess
- #include <BiorthBess.H>
Public Functions
-
BiorthBess(double rmax, int lmax, int nmax, int rnum)
Constructor.
-
void get_potl_dens(double r, Eigen::MatrixXd &p, Eigen::MatrixXd &d)
Potential and density evaluation.
-
std::vector<Eigen::MatrixXd> orthoCheck(int knots = 40)
Compute the orthogonality of the basis by returning inner produce matrices
-
inline virtual ~BiorthBess()
Destructor.
-
BiorthBess(double rmax, int lmax, int nmax, int rnum)
-
class BiorthCube
- #include <BiorthCube.H>
! BiorthCube grid class
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.
-
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)
-
BiorthCube(const YAML::Node &conf)
-
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"]
}](_images/graphviz-2b387e038ee51bec80def031ccd42bee90950678.png)
! 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 double getRtable()
Get the table bounds.
-
inline double getXmax()
-
inline double getXmin()
Get table range bounds.
-
inline double getYmax()
-
inline double getYmin()
-
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
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
-
int cmapR
Grid parameters.
-
int cmapZ
-
YAML::Node conf
-
YAML::Node diskconf
-
double dx
-
double dy
-
bool EVEN_M
-
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
-
double rcylmax
-
double rcylmin
-
double scale
-
bool use_mpi
-
bool verbose
-
double xmax
-
double xmin
-
double ymax
-
double ymin
-
BiorthCyl(const YAML::Node &conf)
-
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"]
}](_images/graphviz-a1a3a6527d4fe143ef90cdc7e90a7f9b4222bcce.png)
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"]
}](_images/graphviz-a1a3a6527d4fe143ef90cdc7e90a7f9b4222bcce.png)
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)
-
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)
-
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()
-
BiorthGrid(AxiSymBioPtr T, double RMIN = 0.0, double RMAX = 20, int NMAX = 10, int LMAX = 10, int RNUM = 400)
-
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"]
}](_images/graphviz-be37c5bc217d75c29cc7d52f589b81a9b5bf2c90.png)
Public Functions
-
void accumulate(double x, double y, double z, double mass)
-
BiorthWake(AxiSymBiorth *BIO, int LMAX, int NMAX)
-
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 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 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)
-
void test_transform(void)
-
void accumulate(double x, double y, double z, double mass)
-
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"]
}](_images/graphviz-7f2cd1480b813c76a18904ad562bc6b552fccae2.png)
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"]
}](_images/graphviz-7f2cd1480b813c76a18904ad562bc6b552fccae2.png)
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)
-
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)
-
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)
-
BSDisk(double RMAX, int NMAX, int MMAX)
-
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"]
}](_images/graphviz-ffca1bd51d4567960cbe173f2ca50dab07fccaf9.png)
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"]
}](_images/graphviz-ffca1bd51d4567960cbe173f2ca50dab07fccaf9.png)
Public Functions
-
BSSphere(double RMAX = 1.0, int NMAX = 10, int LMAX = 10)
-
inline virtual double d_r_to_rb(double const r)
-
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 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)
-
BSSphere(double RMAX = 1.0, int NMAX = 10, int LMAX = 10)
-
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::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 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 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
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)
-
typedef std::conditional<isConst, constcircular_buffer<value_type>*, circular_buffer<value_type>*>::type cbuf_pointer
-
class bw_struct
- #include <BWHelper.H>
-
class BWData
- #include <BarrierWrapper.H>
Public Functions
-
int Owner()
Return the valid node with the lowest rank.
-
int Owner()
-
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"]
}](_images/graphviz-04be409b26be58df75ccc175026720e4d8cc3b19.png)
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"]
}](_images/graphviz-04be409b26be58df75ccc175026720e4d8cc3b19.png)
Wrapper class for std::map to keep a finite size.
Private Members
-
int max_size
-
int max_size
-
class CBDisk : public BasisClasses::BiorthBasis
- #include <BiorthBasis.H>
Inheritence diagram for BasisClasses::CBDisk:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"3" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"2" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis"]
"1" [label="BasisClasses::CBDisk" tooltip="BasisClasses::CBDisk" fillcolor="#BFBFBF"]
"2" -> "3" [dir=forward tooltip="public-inheritance"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-f08dcf46f171ed30178468557038d9c759260e35.png)
Collaboration diagram for BasisClasses::CBDisk:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"3" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"2" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis"]
"1" [label="BasisClasses::CBDisk" tooltip="BasisClasses::CBDisk" fillcolor="#BFBFBF"]
"2" -> "3" [dir=forward tooltip="public-inheritance"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-f08dcf46f171ed30178468557038d9c759260e35.png)
Uses the Clutton-Brock basis to evaluate expansion coeffients and provide potential and density basis fields
Public Types
Public Functions
-
virtual void accumulate(double x, double y, double z, double mass)
Accumulate new coefficients.
-
CBDisk(const YAML::Node &conf)
Constructor from YAML node.
-
virtual std::vector<double> getAccel(double x, double y, double z)
Evaluate acceleration in Cartesian coordinates in centered coordinate system
-
BasisArray getBasis(double logxmin = -3.0, double logxmax = 0.5, int numgrid = 2000)
Return a vector of a vector of 1d basis-function grids for CBDisk, logarithmically spaced between [logxmin, logxmax] (base 10).
-
inline int getMmax()
Return current maximum harmonic order in expansion.
-
inline int getNmax()
Return current maximum order in radial expansion.
-
virtual void make_coefs(void)
Make coefficients after accumulation.
-
std::vector<Eigen::MatrixXd> orthoCheck(int knots = 4000)
Compute the orthogonality of the basis by returning inner produce matrices
-
inline bool orthoTest()
Biorthogonality sanity check.
-
virtual void reset_coefs(void)
Zero out coefficients to prepare for a new expansion.
-
inline virtual ~CBDisk(void)
Destructor.
Public Static Functions
Protected Functions
-
virtual std::vector<double> crt_eval(double x, double y, double z)
Evaluate fields in Cartesian coordinates in centered coordinate system.
-
virtual std::vector<double> cyl_eval(double R, double z, double phi)
Evaluate basis in cylindrical coordinates.
-
virtual void load_coefs(CoefClasses::CoefStrPtr coefs, double time)
Load coefficients into the new CoefStruct.
-
virtual void set_coefs(CoefClasses::CoefStrPtr coefs)
Set coefficients.
Protected Static Attributes
Private Types
Private Functions
-
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)
-
void initialize()
Helper for constructor.
-
double norm(const int n, const int m)
-
double phif(const int n, const int m, const double r)
2D Clutton-Brock basis
-
double potl(const int n, const int m, const double r)
-
virtual void accumulate(double x, double y, double z, double mass)
-
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"]
}](_images/graphviz-12ff2de800afbbcbc8d13b131b52a0d91b64536e.png)
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"]
"20" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"19" [label="CoefClasses::CylCoefs" tooltip="CoefClasses::CylCoefs"]
"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"]
"19" -> "20" [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"]
"4" -> "19" [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"]
}](_images/graphviz-3a56745e54a42e551c0288fd4e49509a1cac107b.png)
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)
-
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)
-
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
Private Functions
-
inline virtual std::tuple<double, double, double> background(double r, double z)
Background evaluation.
-
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
-
virtual double potl(const int n, const int m, const double r)
-
void setBackground()
Set background from YAML.
-
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"]
}](_images/graphviz-965465aab8dd9aa2063c2800e1b5104875f3563c.png)
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"]
}](_images/graphviz-965465aab8dd9aa2063c2800e1b5104875f3563c.png)
Public Functions
-
CBSphere(void)
-
virtual double d_r_to_rb(double const)
-
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 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()
-
CBSphere(void)
-
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—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.
-
CenterFile(const YAML::Node &conf)
-
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"]
}](_images/graphviz-973d4f724007ca99793b5f66cba856a793093dd2.png)
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"]
}](_images/graphviz-973d4f724007ca99793b5f66cba856a793093dd2.png)
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)
-
inline Cheb1(void)
-
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"]
}](_images/graphviz-670172e967ff93ae4abda7b2b122b276a916cccc.png)
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"]
}](_images/graphviz-670172e967ff93ae4abda7b2b122b276a916cccc.png)
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)
-
inline Cheb2(void)
-
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"]
}](_images/graphviz-4dbd9816711feba5bc618d62c784465e2d15b3f0.png)
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"]
}](_images/graphviz-4dbd9816711feba5bc618d62c784465e2d15b3f0.png)
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_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.
-
inline virtual double xhi()
-
inline virtual double xlo()
Data limits.
-
~Cheby1d()
Destructor.
Private Functions
-
double chebint(double x)
-
void bomb(const char*, ...)
-
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 Static Attributes
-
static time_t delta
Safety time interval [Default: 10 minute warning].
-
static time_t diag
Diagnostic output interval [Default: 2 hours].
-
static time_t delta
-
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 Functions
-
inline const_reference at(size_type index) const
-
inline const_reference back() const
-
inline const_iterator begin() 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 const_iterator end() const
-
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 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 const_iterator rend() const noexcept
-
inline const_reference at(size_type index) const
-
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"]
}](_images/graphviz-2bea4d69ea8d49fdbad5db2a146541e4fc7ebf40.png)
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"]
}](_images/graphviz-2bea4d69ea8d49fdbad5db2a146541e4fc7ebf40.png)
-
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"]
}](_images/graphviz-f0124649cb0f3fb05ddf2965dde691041899a451.png)
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"]
}](_images/graphviz-f0124649cb0f3fb05ddf2965dde691041899a451.png)
-
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"]
}](_images/graphviz-2566bc27fd429063e2134d66011c35162eb398e9.png)
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"]
}](_images/graphviz-2566bc27fd429063e2134d66011c35162eb398e9.png)
-
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"]
}](_images/graphviz-56f2ccb23351296321cfa1a67e5ddbf1df0de325.png)
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"]
}](_images/graphviz-56f2ccb23351296321cfa1a67e5ddbf1df0de325.png)
-
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"]
}](_images/graphviz-5195fef94bcc81f4d93d2c68a41c39dcae459e2c.png)
Subclassed by Disk2dHalo::CLin, Disk2dHalo::CLog, Disk2dHalo::CRat
-
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"]
}](_images/graphviz-0e773d7f0a1923892d0e16de66e5f988f6235742.png)
Subclassed by DiskHalo::CLin, DiskHalo::CLog, DiskHalo::CRat
-
class CoefContainer
- #include <CoefContainer.H>tmin: 0.0 tmax: 2.0 runtag: run1 components: disk: filename: outcoef.star.run1 geometry: cylinder keys:
A uniform interface to a group of CoefDB instances The container reads a YAML configuration file and creates a container of coefficient files, one for each stanza in the 'components' sequence in the YAML file. There are 4 global parameters as well: @tmin: the minimum time to include in the time series @tmax: the maximum time to include in the time series @stride: the number of intermediate coefficient bunches to skip @runtag: an internal tag for prefixing output files An example YAML file might look something like this:
[0, 16, 0]
[0, 17, 0]
[0, 18, 0]
[0, 19, 0] halo: filename: outcoef.dark.run1 geometry: sphere keys:
[1, 0, 4, 0]
[1, 0, 5, 0]
[1, 0, 6, 0]
[1, 0, 7, 0] …
This reads in two coefficient files, outcoef.star.run1 and outcoef.halo.run1, respectively. The first is a cylindrical disk and the second is a spherical halo. The coefficient type is specified by the 'geometry' tag. The 'keys' describe the coefficient channels from each set to be included in the MSSA analysis. In the cylindrical case, the key index sequence is: azimuthal harmonic (in this case: m=0), the radial orders (in this case: n=16,17,18,19), and the cosine (0) or sine (1) coefficients. In this case, only cosines. In the spherical case, the key index sequence is: the spherical harmonic pair l and m (in this case: l=1, m=0), the radial orders (in this case: n=4,5,6,7), and the cosine (0) or sine (1) coefficients. In this case, only cosines.
Public Functions
-
inline void background()
Copy data from backround back to the coefficient database.
-
inline CoefContainer()
Null constructor.
-
CoefContainer(const CoefContainer &p)
Copy constructor.
-
CoefContainer(const mssaConfig &config, const std::string spec = "")
Instantiate all components DBs from structure.
-
std::shared_ptr<CoefContainer> deepcopy()
Copy all of the data; make new instances of shared pointer objects
-
inline std::map<std::string, CoefClasses::CoefsPtr> endUpdate()
Update the working data to the working coefficients and return a map.
-
inline CoefClasses::CoefsPtr getCoefs(const std::string &name)
Access to coefficients.
-
inline const std::vector<double> &getData(std::vector<unsigned> key)
Return a particular data stream.
-
inline int index(const std::string name)
Get index with associated name. Returns -1 if name is not found.
Public Members
-
double tmax
-
class CoefDB
- #include <CoefContainer.H>
Base class for per component coefficients.
Public Functions
-
void background()
Copy data from backround back to the coefficient database.
-
inline CoefDB()
Null constructor.
-
CoefDB(const std::string &name, CoefClasses::CoefsPtr coefs, const std::vector<Key> &keys, const std::vector<Key> &bkeys, unsigned index, unsigned stride = 1, double tmin = -std::numeric_limits<double>::max(), double tmax = std::numeric_limits<double>::max())
Constructor.
-
std::shared_ptr<CoefDB> deepcopy()
Copy all of the data; make new instances of shared pointer objects
-
CoefClasses::CoefsPtr endUpdate()
Update and return working copy of coefficients.
-
inline CoefClasses::CoefsPtr getCoefs()
Access to coefficients.
Public Members
-
std::map<Key, std::vector<double>, mSSAkeyCompare> data
Database itself.
Protected Functions
-
void pack_channels()
Packing routines.
Reflect type
-
void pack_cylfld()
Cylindrical coefficients.
-
void pack_cylinder()
Cylindrical coefficients.
-
void pack_slab()
Slab coefficients.
-
void pack_sphere()
Spherical coefficients.
-
void pack_sphfld()
Spherical field coefficients.
-
void pack_table()
Table coefficients.
-
void pack_traj()
Trajectories.
-
void restore_background_cylinder()
-
void restore_background_sphere()
-
void unpack_cube()
-
void unpack_cylfld()
-
void unpack_cylinder()
-
void unpack_slab()
-
void unpack_sphere()
-
void unpack_sphfld()
-
void unpack_table()
-
void unpack_traj()
Protected Attributes
-
CoefClasses::CoefsPtr coefs
Coefficients.
-
bool complexKey
Complex keys.
-
unsigned index
Index of component.
-
int stride
Not sure we need this since data stream assembly will happen upstream
-
double tmax
-
double tmin
Friends
- friend class CoefContainer
-
void background()
-
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"]
}](_images/graphviz-54bd9c7118c2071ef8db485e8beb3b9cd2bfea20.png)
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"]
}](_images/graphviz-54bd9c7118c2071ef8db485e8beb3b9cd2bfea20.png)
-
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"]
}](_images/graphviz-924ba0ba865c6d1b3da0aa0a318ade19732317bc.png)
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"]
}](_images/graphviz-924ba0ba865c6d1b3da0aa0a318ade19732317bc.png)
-
class Coefs
- #include <Coefficients.H>
Inheritence diagram for CoefClasses::Coefs:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"1" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs" fillcolor="#BFBFBF"]
"2" [label="CoefClasses::CubeCoefs" tooltip="CoefClasses::CubeCoefs"]
"3" [label="CoefClasses::CylCoefs" tooltip="CoefClasses::CylCoefs"]
"4" [label="CoefClasses::CylFldCoefs" tooltip="CoefClasses::CylFldCoefs"]
"5" [label="CoefClasses::SlabCoefs" tooltip="CoefClasses::SlabCoefs"]
"6" [label="CoefClasses::SphCoefs" tooltip="CoefClasses::SphCoefs"]
"7" [label="CoefClasses::SphFldCoefs" tooltip="CoefClasses::SphFldCoefs"]
"8" [label="CoefClasses::TableData" tooltip="CoefClasses::TableData"]
"9" [label="CoefClasses::TrajectoryData" tooltip="CoefClasses::TrajectoryData"]
"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"]
}](_images/graphviz-80b6b1a9c059fd5b1d9a76c55f4e6d9c49f9d179.png)
Abstract class for any type of coefficient database
Can read and write EXP native and EXP H5 coefficient formats. Provides access to coefficients by time. Provides a factory member that returns derived class instances.
Subclassed by CoefClasses::CubeCoefs, CoefClasses::CylCoefs, CoefClasses::CylFldCoefs, CoefClasses::SlabCoefs, CoefClasses::SphCoefs, CoefClasses::SphFldCoefs, CoefClasses::TableData, CoefClasses::TrajectoryData
Public Functions
-
virtual void add(CoefStrPtr coef) = 0
Add a coefficient structure to the container.
-
virtual void clear() = 0
Clear coefficient container.
Compare two collections of stanzas (this is for testing only)
-
virtual std::shared_ptr<Coefs> deepcopy() = 0
Copy all of the data; make new instances of shared pointer objects
-
virtual std::shared_ptr<CoefStruct> getCoefStruct(double time) = 0
Get coefficient structure at a given time.
-
std::tuple<Eigen::VectorXcd&, bool> interpolate(double time)
Interpolate coefficient matrix at given time.
-
virtual Eigen::MatrixXd &Power(int min = 0, int max = std::numeric_limits<int>::max()) = 0
Get power for the coefficient DB as a function of harmonic index. Time as rows, harmonics as columns.
- Parameters:
min – is the minimum radial order
max – is the maximum radial order
-
virtual void setData(double time, Eigen::VectorXcd &data) = 0
Set coefficient store at given time to the provided matrix.
-
inline void setDeltaT(double dT)
Set maximum grid interpolation offset.
-
virtual void zerodata() = 0
Zero the existing data.
-
inline virtual ~Coefs()
Destructor.
Public Static Functions
Joint factory and update member
If Coefs pointer is null: Creates a coefficient container based on the initial set of coefficients and adds them to the internal container
If Coefs pointer is not null: Use add() member to add new coefficients to the exising container
This factory would be used with Basis::Basis to derive coefficients from snapshots.
-
static std::shared_ptr<Coefs> factory(const std::string &file, int stride = 1, double tmin = -std::numeric_limits<double>::max(), double tmax = std::numeric_limits<double>::max())
The coefficient factory members
Creates a shared pointer to derived instance of the desired type and returns it. This uses a coefficient file to construct the coefficient database
Protected Functions
Copy all of the base-class data.
-
virtual void readNativeCoefs(const std::string &file, int stride, double tmin, double tmax) = 0
Read the coefficients.
-
inline double roundTime(double time)
Round time key to emulated fixed-point arithmetic.
-
virtual void WriteH5Params(HighFive::File &file) = 0
Write parameter attributes (needed for derived classes)
-
virtual unsigned WriteH5Times(HighFive::Group &group, unsigned count) = 0
Write coefficient data in H5.
Protected Attributes
-
bool verbose
Verbose debugging output.
-
virtual void add(CoefStrPtr coef) = 0
-
struct Coefs
- #include <TwoDCoefs.H>
-
class CoefsError : public std::runtime_error
- #include <Coefficients.H>
Inheritence diagram for CoefClasses::Coefs::CoefsError:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"1" [label="CoefClasses::Coefs::CoefsError" tooltip="CoefClasses::Coefs::CoefsError" fillcolor="#BFBFBF"]
"2" [label="std::runtime_error" tooltip="std::runtime_error"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-6c66def394c9d86619600db5ebc51e8b4836c5b7.png)
Collaboration diagram for CoefClasses::Coefs::CoefsError:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"1" [label="CoefClasses::Coefs::CoefsError" tooltip="CoefClasses::Coefs::CoefsError" fillcolor="#BFBFBF"]
"2" [label="std::runtime_error" tooltip="std::runtime_error"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-6c66def394c9d86619600db5ebc51e8b4836c5b7.png)
-
class CoefStruct
- #include <CoefStruct.H>
Inheritence diagram for CoefClasses::CoefStruct:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"1" [label="CoefClasses::CoefStruct" tooltip="CoefClasses::CoefStruct" fillcolor="#BFBFBF"]
"2" [label="CoefClasses::CubeStruct" tooltip="CoefClasses::CubeStruct"]
"3" [label="CoefClasses::CylFldStruct" tooltip="CoefClasses::CylFldStruct"]
"4" [label="CoefClasses::CylStruct" tooltip="CoefClasses::CylStruct"]
"5" [label="CoefClasses::SlabStruct" tooltip="CoefClasses::SlabStruct"]
"6" [label="CoefClasses::SphFldStruct" tooltip="CoefClasses::SphFldStruct"]
"7" [label="CoefClasses::SphStruct" tooltip="CoefClasses::SphStruct"]
"8" [label="CoefClasses::TblStruct" tooltip="CoefClasses::TblStruct"]
"9" [label="CoefClasses::TrajStruct" tooltip="CoefClasses::TrajStruct"]
"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"]
}](_images/graphviz-98278f27ccb37f4f29ab8113294352dfd1bb9b03.png)
This is a general struct for any dimensionality.
Subclassed by CoefClasses::CubeStruct, CoefClasses::CylFldStruct, CoefClasses::CylStruct, CoefClasses::SlabStruct, CoefClasses::SphFldStruct, CoefClasses::SphStruct, CoefClasses::TblStruct, CoefClasses::TrajStruct
Public Functions
Copy base-class fields.
-
virtual void create() = 0
Create an empty data storage.
-
virtual std::shared_ptr<CoefStruct> deepcopy() = 0
Make a complete copy into a new instance.
-
inline Eigen::Ref<const Eigen::VectorXcd> getCoefs()
Read-only access to coefficient data (no copy)
-
inline double getTime()
Read-only access to center (no copy)
-
virtual bool read(std::istream &in, bool exp_type, bool verbose = false) = 0
Read data from a stream.
-
inline void setTime(double &STORE)
Set coefficient time (no copy)
-
inline virtual void zerodata()
Zero the existing data.
-
inline virtual ~CoefStruct()
Destructor.
-
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"]
}](_images/graphviz-acb2617b594eeea48cd4d0979a9e9a92fb60c59f.png)
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"]
}](_images/graphviz-acb2617b594eeea48cd4d0979a9e9a92fb60c59f.png)
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.
-
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"]
}](_images/graphviz-8cb6f0bb0ac5507203f322e8355f637fad159757.png)
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"]
}](_images/graphviz-8cb6f0bb0ac5507203f322e8355f637fad159757.png)
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.
-
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.
-
inline void addColorPoint(float red, float green, float blue, float value)
-
struct ColorPoint
Public Functions
-
inline ColorPoint(float red, float green, float blue, float value)
-
inline ColorPoint(float red, float green, float blue, float value)
-
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"]
}](_images/graphviz-1471d202476f055274eaebdac85f6435ccbdbbac.png)
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:name of the potential solver (force methods) for this phase space
component-specific parameters [see Parameter section below]
file name containing phase space to be read
comma-delimited parameter list passed to the potential solver
Currently available force methods:
Reference frames:
Inertial is the rest reference frame whose coordinate system is centered at (0, 0, 0)
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_systemis off, this is the same as InertialCentered 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.
keyPos is the value of the species key in the particle integer attribute vector
pbufsiz is the number of particles in each particle buffer sent to disk when using MPI-IO with OutPSP
blocking set to true chooses blocking writes when using MPI-IO with OutPSP
buffered set to true chooses buffered writes when using POSIX binary
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
centerbeyond which it does not contribute to the force expansion (but does continues to be affected by it). The default value is1.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
tonortoffis 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
-
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.
-
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.
-
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.
-
template<typename T>
void write_HDF5(HighFive::Group &group, bool masses, bool IDs) Write HDF5 phase-space structure for real or float.
Gadget style
-
void write_binary_header(ostream *out, bool real4, std::string prefix, int nth = 1)
Write header for per-node writes.
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 — current node M — 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?
-
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.
-
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 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 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 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.
-
inline void setH5(int compress, bool shuffle, int chunk)
Set H5 compression parameters; in principle, compression can be set per component, although it is set to be the same for all components currently.
Public Types
Public Members
-
double *angmom
Angular momentum vector.
-
YAML::Node cconf
Parameters for component.
-
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.
-
YAML::Node fconf
Parameters for force.
-
int keyPos
Species key position in particle integer attribute vector.
-
bool point_mass
Point masses.
-
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.
-
std::shared_ptr<CenterFile> CF
Center file playback.
-
int com_restart
COM flag.
-
string comfile
COM log file.
-
bool dtreset
Select level from criteria over last time step.
-
bool freezeLev
Compute new levels on the first step only.
-
int H5chunk = 4096
-
int H5compress = 0
HDF5 compression parameters.
-
bool H5shuffle = true
-
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.
-
int nlevel
Level occupation output.
-
bool noswitch
No multistep switching.
-
vector<double> orates
Vectors for holding the rates per node for load balancing.
-
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
Private Functions
-
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
-
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
Friends
- friend class ComponentContainer
- friend class OrbTrace
- friend class ScatterMFP
-
class ComponentContainer
- #include <ComponentContainer.H>
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"]
}](_images/graphviz-cd476c00f2dd51c2a8fb5e8b0724fceaa840f216.png)
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
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<std::shared_ptr<Interaction>> interaction
List of interactions.
-
int ncomp
Number of components.
-
int ntot
Total number of bodies.
-
enum ComponentContainer::State state
-
bool thread_timing
-
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
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
-
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)
-
inline ComponentHeader()
-
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"]
}](_images/graphviz-34f936909490e0d7e2ce8455b6841287d2a6f280.png)
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.
-
inline CoordMap(double H)
-
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)
-
inline coulombSelect()
-
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"]
}](_images/graphviz-2234ea7af5812ea5893ebd37a27e3cb169ac0136.png)
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"]
}](_images/graphviz-2234ea7af5812ea5893ebd37a27e3cb169ac0136.png)
Public Functions
-
CPoly(const int)
-
CPoly(int, double*)
-
CPoly(void)
-
inline const int getorder(void)
-
inline void Pop(int i)
-
void print(ostream&)
Private Functions
-
void reduce_order(void)
Private Members
-
int order
-
CPoly(const int)
-
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"]
}](_images/graphviz-5fd1e6b740898a287122decc22e6e3b68d56cc07.png)
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"]
}](_images/graphviz-5fd1e6b740898a287122decc22e6e3b68d56cc07.png)
Public Functions
-
inline CRat(double scale)
-
inline virtual double r_to_x(double r)
-
inline virtual double x_to_r(double x)
Public Members
-
double scale
-
inline CRat(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"]
}](_images/graphviz-e85dc7ab00b1aae9605a6cf4fb2fd9761b4e03c5.png)
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"]
}](_images/graphviz-e85dc7ab00b1aae9605a6cf4fb2fd9761b4e03c5.png)
Public Functions
-
inline CRat(double scale)
-
inline virtual double r_to_x(double r)
-
inline virtual double x_to_r(double x)
Public Members
-
double scale
-
inline CRat(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 std::vector<Y> operator()(const std::vector<X> &xx) const
Evaluation operator for vector input, assuming xx is sorted ascending.
-
inline virtual ~Cspline()
Destructor.
Protected Types
-
typedef Element element_type
Protected Attributes
-
std::vector<element_type> elems
-
inline Cspline()
-
class Cube : public BasisClasses::BiorthBasis
- #include <BiorthBasis.H>
Inheritence diagram for BasisClasses::Cube:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"3" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"2" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis"]
"1" [label="BasisClasses::Cube" tooltip="BasisClasses::Cube" fillcolor="#BFBFBF"]
"2" -> "3" [dir=forward tooltip="public-inheritance"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-666d1efa5d103421e8f87950ba1da3abb8353618.png)
Collaboration diagram for BasisClasses::Cube:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"3" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"2" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis"]
"1" [label="BasisClasses::Cube" tooltip="BasisClasses::Cube" fillcolor="#BFBFBF"]
"2" -> "3" [dir=forward tooltip="public-inheritance"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-666d1efa5d103421e8f87950ba1da3abb8353618.png)
Uses the BiorthCyl basis to evaluate expansion coeffients and provide potential and density basis fields
Public Types
Public Functions
-
virtual void accumulate(double x, double y, double z, double mass)
Accumulate new coefficients.
-
Cube(const YAML::Node &conf)
Constructor from YAML node.
-
virtual std::vector<double> getAccel(double x, double y, double z)
Evaluate acceleration in Cartesian coordinates in centered coordinate system
-
virtual void make_coefs(void)
Make coefficients after accumulation.
-
std::vector<Eigen::MatrixXd> orthoCheck(int knots = 40)
Compute the orthogonality of the basis by returning inner produce matrices
-
inline bool orthoTest()
Biorthogonality sanity check.
-
virtual void reset_coefs(void)
Zero out coefficients to prepare for a new expansion.
-
inline virtual ~Cube(void)
Destructor.
Protected Functions
-
virtual std::vector<double> crt_eval(double x, double y, double z)
Evaluate basis in Cartesian coordinates.
-
virtual std::vector<double> cyl_eval(double r, double z, double phi)
Evaluate basis in cylindrical coordinates.
-
virtual void load_coefs(CoefClasses::CoefStrPtr coefs, double time)
Load coefficients into the new CoefStruct.
-
virtual void set_coefs(CoefClasses::CoefStrPtr coefs)
Set coefficients.
Protected Static Attributes
Private Functions
-
void initialize()
Initialization helper.
Private Members
-
int knots
Number of integration knots for orthogonal check.
-
int nmaxx
Maximum expansion order for construction.
-
int nmaxy
-
int nmaxz
-
int nminx
Minimum expansion order for restriction.
-
int nminy
-
int nminz
-
int npart
Number of particles.
-
std::shared_ptr<BiorthCube> ortho
Orthogonal basis instance.
-
double totalMass
Notal mass on grid.
-
unsigned used
Number of particles used to compute grid.
-
virtual void accumulate(double x, double y, double z, double mass)
-
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"]
}](_images/graphviz-5da37f18cd753b1c752d820ad7da8db6ccc4230f.png)
Collaboration diagram for Cube:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"9" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"8" [label="CoefClasses::CubeCoefs" tooltip="CoefClasses::CubeCoefs"]
"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"]
"8" -> "9" [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"]
"5" -> "6" [dir=forward tooltip="usage"]
"2" -> "3" [dir=forward tooltip="usage"]
"2" -> "4" [dir=forward tooltip="usage"]
"3" -> "2" [dir=forward tooltip="usage"]
}](_images/graphviz-43da12432fad4ad72d950b76dc563b5a80a92d15.png)
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
-
virtual void determine_coefficients(void)
Compute the coefficients.
-
virtual ~Cube()
Destructor.
Private Types
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
ifrom levelcurto levelnext
-
virtual void multistep_update_finish()
Execute to finish level shifts for particles.
Private Members
-
bool byPlanes
Plane method (default: true)
-
CoefClasses::CubeCoefs cubeCoefs
Coefficient container instance for writing HDF5.
-
double dfac
-
std::vector<coefTypePtr> expcoefL
-
std::vector<coefTypePtr> expcoefN
-
int imx
Variables.
-
int imy
-
int imz
-
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
-
int use0
-
int use1
-
class CubeCoefs : public CoefClasses::Coefs
- #include <Coefficients.H>
Inheritence diagram for CoefClasses::CubeCoefs:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"1" [label="CoefClasses::CubeCoefs" tooltip="CoefClasses::CubeCoefs" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-1227c4de953f070b1df3ad7049e4308fd86df363.png)
Collaboration diagram for CoefClasses::CubeCoefs:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"1" [label="CoefClasses::CubeCoefs" tooltip="CoefClasses::CubeCoefs" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-1227c4de953f070b1df3ad7049e4308fd86df363.png)
Derived class for cube coefficients
Public Functions
-
virtual void add(CoefStrPtr coef)
Add a coefficient structure to the container.
-
inline virtual void clear()
Clear coefficient container.
Compare two collections of stanzas (this is for testing only)
-
inline CubeCoefs(bool verbose = false)
Constructor.
-
CubeCoefs(HighFive::File &file, int stride = 1, double tmin = -std::numeric_limits<double>::max(), double tmax = std::numeric_limits<double>::max(), bool verbose = false)
H5 constructor.
-
virtual std::shared_ptr<Coefs> deepcopy()
Copy all of the data; make new instances of shared pointer objects
-
void dump(int nmaxx, int nmaxy, int nmaxz)
Dump to ascii list for testing.
-
inline virtual std::shared_ptr<CoefStruct> getCoefStruct(double time)
Get coefficient structure at a given time.
-
inline std::tuple<Eigen::Tensor<std::complex<double>, 3>&, bool> interpolate(double time)
Interpolate coefficient tensor at given time.
-
inline double nmax(char d) const
Get nmax.
-
Eigen::MatrixXd &Power(char d, int min = 0, int max = std::numeric_limits<int>::max())
Get power for the coefficient DB as a function of harmonic index by dimension: x, y, z specified as a quoted char
-
inline virtual Eigen::MatrixXd &Power(int min = 0, int max = std::numeric_limits<int>::max())
Get power for the coefficient DB as a function of harmonic index. Time as rows, harmonics as columns. ‘x’ dimension by default.
- Parameters:
min – is the minimum radial order
max – is the maximum radial order
-
inline virtual void zerodata()
Zero the existing data.
Protected Functions
-
virtual void readNativeCoefs(const std::string &file, int stride, double tmin, double tmax)
Read the coefficients.
-
virtual void WriteH5Params(HighFive::File &file)
Write parameter attributes.
-
virtual unsigned WriteH5Times(HighFive::Group &group, unsigned count)
Write coefficient data in H5.
-
virtual void add(CoefStrPtr coef)
-
class CubeStruct : public CoefClasses::CoefStruct
- #include <CoefStruct.H>
Inheritence diagram for CoefClasses::CubeStruct:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::CoefStruct" tooltip="CoefClasses::CoefStruct"]
"1" [label="CoefClasses::CubeStruct" tooltip="CoefClasses::CubeStruct" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-e1dff53c35ff974d43098821eced854814bd5306.png)
Collaboration diagram for CoefClasses::CubeStruct:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::CoefStruct" tooltip="CoefClasses::CoefStruct"]
"1" [label="CoefClasses::CubeStruct" tooltip="CoefClasses::CubeStruct" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-e1dff53c35ff974d43098821eced854814bd5306.png)
Specialization of CoefStruct for a cube.
Public Types
Public Functions
-
inline void allocate()
Allocate storage arrays.
-
virtual void create()
Create an empty data storage.
-
inline CubeStruct()
Constructor.
-
virtual std::shared_ptr<CoefStruct> deepcopy()
Copy all of data contents to a new instance.
-
inline void allocate()
-
class Cubic_Table
- #include <cubic.H>
Public Functions
-
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)
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)
-
inline Cubic_Table(Cubic_Table &c)
-
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"]
}](_images/graphviz-aff4fe049d50785713dd485389d56ed52324a008.png)
Public Types
Public Functions
-
inline bool operator!=(const CyclicIterator &x) const
Test for inequality.
-
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 bool operator==(const CyclicIterator &x) const
Test for equality.
-
inline bool operator!=(const CyclicIterator &x) const
-
class CylCoefs : public CoefClasses::Coefs
- #include <Coefficients.H>
Inheritence diagram for CoefClasses::CylCoefs:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"1" [label="CoefClasses::CylCoefs" tooltip="CoefClasses::CylCoefs" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-df36c25cdd9e3922f07d0bae812077b80004d238.png)
Collaboration diagram for CoefClasses::CylCoefs:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"1" [label="CoefClasses::CylCoefs" tooltip="CoefClasses::CylCoefs" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-df36c25cdd9e3922f07d0bae812077b80004d238.png)
Derived class for cylindrical coefficients
Public Functions
-
virtual void add(CoefStrPtr coef)
Add a coefficient structure to the container.
-
inline virtual void clear()
Clear coefficient container.
Compare two collections of stanzas (this is for testing only)
-
inline CylCoefs(bool verbose = false)
Constructor.
-
inline CylCoefs(const std::string &file, int stride = 1, double tmin = -std::numeric_limits<double>::max(), double tmax = std::numeric_limits<double>::max(), bool verbose = false)
Native file constructor.
-
CylCoefs(HighFive::File &file, int stride = 1, double tmin = -std::numeric_limits<double>::max(), double tmax = std::numeric_limits<double>::max(), bool verbose = false)
H5 constructor.
-
virtual std::shared_ptr<Coefs> deepcopy()
Copy all of the data; make new instances of shared pointer objects
-
void dump(int mmin, int mmax, int nmin, int nmax)
Dump to ascii list for testing.
-
std::tuple<Eigen::MatrixXd&, Eigen::MatrixXd&> EvenOddPower(int nodd = -1, int min = 0, int max = std::numeric_limits<int>::max())
Get power for the coefficient DB as a function of harmonic index, separating the vertically even and odd symmetric coefficients. Time as rows, harmonics as columns.
- Parameters:
min – is the minimum radial order
max – is the maximum radial order
nodd – is the index position of the first vertically odd coefficient
-
inline virtual std::shared_ptr<CoefStruct> getCoefStruct(double time)
Get coefficient structure at a given time.
-
inline std::tuple<Eigen::MatrixXcd&, bool> interpolate(double time)
Interpolate coefficient matrix at given time.
-
inline double mmax() const
Get mmax.
-
inline double nmax() const
Get lmax.
-
virtual Eigen::MatrixXd &Power(int min = 0, int max = std::numeric_limits<int>::max())
Get power for the coefficient DB as a function of harmonic index. Time as rows, harmonics as columns.
- Parameters:
min – is the minimum radial order
max – is the maximum radial order
-
inline virtual void zerodata()
Zero the existing data.
Protected Functions
-
virtual void readNativeCoefs(const std::string &file, int stride, double tmin, double tmax)
Read the coefficients.
-
virtual void WriteH5Params(HighFive::File &file)
Write parameter attributes.
-
virtual unsigned WriteH5Times(HighFive::Group &group, unsigned count)
Write coefficient data in H5.
-
virtual void add(CoefStrPtr coef)
-
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"]
}](_images/graphviz-5b758eb532ee76a9dd8d4309125dd7a923ee7277.png)
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"]
}](_images/graphviz-b140bd3c90bcce18cc929a795af4d0bc6b2cab57.png)
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)
Private Functions
-
void setup_model(double rmin, double rmax)
-
inline virtual double d2fde2(double E, double L)
-
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"]
}](_images/graphviz-535b59f37dd5eded64194143c1a3b544ccefdfdc.png)
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"]
}](_images/graphviz-af0387e3876e249892706184358421c3655e0571.png)
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
ifrom levelcurto levelnext
-
virtual void multistep_update_finish()
Protected Attributes
Friends
- friend class Cylinder
-
void compute_multistep_coefficients(unsigned mlevel)
-
class CylFldCoefs : public CoefClasses::Coefs
- #include <Coefficients.H>
Inheritence diagram for CoefClasses::CylFldCoefs:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"1" [label="CoefClasses::CylFldCoefs" tooltip="CoefClasses::CylFldCoefs" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-34786cd4c09fd5630022824b0b876ed96dadbc94.png)
Collaboration diagram for CoefClasses::CylFldCoefs:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"1" [label="CoefClasses::CylFldCoefs" tooltip="CoefClasses::CylFldCoefs" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-34786cd4c09fd5630022824b0b876ed96dadbc94.png)
Derived class for spherical field coefficients
Public Functions
-
virtual void add(CoefStrPtr coef)
Add a coefficient structure to the container.
-
inline virtual void clear()
Clear coefficient container.
Compare two collections of stanzas (this is for testing only)
-
inline CylFldCoefs(bool verbose = false)
Constructor.
-
inline CylFldCoefs(CylFldCoefs &p)
Copy constructor.
-
CylFldCoefs(HighFive::File &file, int stride = 0, double tmin = -std::numeric_limits<double>::max(), double tmax = std::numeric_limits<double>::max(), bool verbose = false)
H5 constructor.
-
virtual std::shared_ptr<Coefs> deepcopy()
Copy all of the data; make new instances of shared pointer objects
-
Eigen::Tensor<std::complex<double>, 4> getAllCoefs()
Get all coefficients indexed in index, l, m, n, time.
-
inline virtual std::shared_ptr<CoefStruct> getCoefStruct(double time)
Get coefficient structure at a given time.
-
CylFldStruct::dataType getMatrix(double time)
Operator for pyEXP.
-
inline std::tuple<CylFldStruct::coefType&, bool> interpolate(double time)
Interpolate coefficient matrix at given time.
-
inline double mmax() const
Get mmax.
-
inline double nfld() const
Get number of fields.
-
inline double nmax() const
Get lmax.
-
virtual Eigen::MatrixXd &Power(int min = 0, int max = std::numeric_limits<int>::max())
Get power for the coefficient DB as a function of harmonic index. Time as rows, harmonics as columns.
- Parameters:
min – is the minimum radial order
max – is the maximum radial order
-
void setMatrix(double time, CylFldStruct::dataType &mat)
Natural data setter for pyEXP.
-
inline virtual void zerodata()
Zero the existing data.
Protected Functions
-
inline virtual void readNativeCoefs(const std::string &file, int stride, double tmin, double tmax)
Read the coefficients.
-
virtual void WriteH5Params(HighFive::File &file)
Write parameter attributes.
-
virtual unsigned WriteH5Times(HighFive::Group &group, unsigned count)
Write coefficient data in H5.
-
virtual void add(CoefStrPtr coef)
-
class CylFldStruct : public CoefClasses::CoefStruct
- #include <CoefStruct.H>
Inheritence diagram for CoefClasses::CylFldStruct:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::CoefStruct" tooltip="CoefClasses::CoefStruct"]
"1" [label="CoefClasses::CylFldStruct" tooltip="CoefClasses::CylFldStruct" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-1b1560826da4cda9ccc499d6a48ffdfb6fa518a9.png)
Collaboration diagram for CoefClasses::CylFldStruct:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::CoefStruct" tooltip="CoefClasses::CoefStruct"]
"1" [label="CoefClasses::CylFldStruct" tooltip="CoefClasses::CylFldStruct" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-1b1560826da4cda9ccc499d6a48ffdfb6fa518a9.png)
Specialization of CoefStruct for disks for general fields.
Public Types
-
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"]
}](_images/graphviz-ddedc41d38482de731abc96589b2035b520b2f97.png)
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"]
"12" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"11" [label="CoefClasses::CylCoefs" tooltip="CoefClasses::CylCoefs"]
"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"]
"11" -> "12" [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"]
"1" -> "11" [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"]
}](_images/graphviz-c70c6325eb7bf050bf21b533f01fab44f3f349a2.png)
This routine computes the potential, acceleration and density using the Cylindrical biorthogonal expansion.
YAML configuration
- 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?)
-
void dump_mzero(const string &name, int step)
Sanity check on grid: dumps SM-style images of initial field.
-
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
ifrom levelcurto levelnext.
-
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
-
void occt_output()
Print deep debugging data.
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
-
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
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
-
int cmapR
-
int cmapZ
-
bool compute
-
double cylmass
-
bool dump_basis
-
int eof
-
bool EVEN_M
-
bool firstime
-
bool firstime_coef
-
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
-
bool pcadiag
-
bool pcaeof
-
bool pcainit
-
bool pcavar
-
bool pcavtk
-
int pnum
-
bool precond
-
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
-
class Cylindrical : public BasisClasses::BiorthBasis
- #include <BiorthBasis.H>
Inheritence diagram for BasisClasses::Cylindrical:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"3" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"2" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis"]
"1" [label="BasisClasses::Cylindrical" tooltip="BasisClasses::Cylindrical" fillcolor="#BFBFBF"]
"2" -> "3" [dir=forward tooltip="public-inheritance"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-9edec1880ca110d08a6ba375f9fe83b9a03690ce.png)
Collaboration diagram for BasisClasses::Cylindrical:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"3" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"2" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis"]
"1" [label="BasisClasses::Cylindrical" tooltip="BasisClasses::Cylindrical" fillcolor="#BFBFBF"]
"2" -> "3" [dir=forward tooltip="public-inheritance"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-9edec1880ca110d08a6ba375f9fe83b9a03690ce.png)
Uses EmpCylSL basis to evaluate expansion coeffients and provide potential and density basis fields
Public Types
Public Functions
-
virtual void accumulate(double x, double y, double z, double mass)
Accumulate new coefficients.
-
Cylindrical(const YAML::Node &conf)
Constructor from YAML node.
-
virtual std::vector<double> getAccel(double x, double y, double z)
Evaluate acceleration in Cartesian coordinates in centered coordinate system
-
BasisArray getBasis(double xmin = 0.0, double xmax = 1.0, int numr = 40, double zmin = -0.1, double zmax = 0.1, int numz = 40, bool linear = true)
Return a vector of vector of basis functions for Cylindrical, linearly spaced between [xmin, xmax] and [zmin, zmax]
-
inline int getMmax()
Return current maximum harmonic order in expansion.
-
inline int getNmax()
Return current maximum order in radial expansion.
-
virtual void make_coefs(void)
Make coefficients after accumulation.
-
inline std::vector<Eigen::MatrixXd> orthoCheck(int knots = 40)
Compute the orthogonality of the basis by returning inner produce matrices
-
inline bool orthoTest()
Biorthogonality sanity check.
-
virtual void reset_coefs(void)
Zero out coefficients to prepare for a new expansion.
-
inline void set_scale(const double scl)
Prescaling factor.
-
inline virtual ~Cylindrical(void)
Destructor.
Public Static Functions
Protected Functions
-
virtual std::vector<double> crt_eval(double x, double y, double z)
Evaluate basis in cartesian coordinates.
-
virtual std::vector<double> cyl_eval(double r, double z, double phi)
Evaluate basis in cylindrical coordinates.
-
virtual void load_coefs(CoefClasses::CoefStrPtr coefs, double time)
Load coefficients into the new CoefStruct.
-
virtual void set_coefs(CoefClasses::CoefStrPtr coefs)
Set coefficients.
Protected Static Attributes
Private Types
-
enum DiskType
DiskType support.
Values:
-
enumerator constant
-
enumerator gaussian
-
enumerator mn
-
enumerator exponential
-
enumerator doubleexpon
-
enumerator diskbulge
-
enumerator python
-
enumerator constant
Private Functions
-
double dcond(double R, double z, double phi, int M)
-
double DiskDens(double R, double z, double phi)
-
void initialize()
Help for constructor.
Private Members
-
double acyl
-
double ashift
-
int cmap
-
int cmapR
-
int cmapZ
-
bool coefs_defined
-
bool density
-
bool deproject
-
double dweight
-
bool EVEN_M
-
bool expcond
-
double hcyl
-
double HERNA
-
double hratio
-
bool Ignore
-
int lmaxfid
-
bool logarithmic
-
double Mfac
-
int mlim
-
int mmax
-
int ncylnx
-
int ncylny
-
int ncylodd
-
int ncylr
-
int nmax
-
int nmaxfid
-
bool oldcache = false
-
int pnum
-
double ppow
-
double rcylmax
-
double rcylmin
-
double rfactor
-
double rmax
-
double rmin
-
int rnum
-
double rscl
-
double rtrunc
-
double rwidth
-
int tnum
-
int used
-
int vflag
-
virtual void accumulate(double x, double y, double z, double mass)
-
class CylStruct : public CoefClasses::CoefStruct
- #include <CoefStruct.H>
Inheritence diagram for CoefClasses::CylStruct:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::CoefStruct" tooltip="CoefClasses::CoefStruct"]
"1" [label="CoefClasses::CylStruct" tooltip="CoefClasses::CylStruct" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-53ed253ec87d19a5d1a4d9cb5faf82770fd90dcc.png)
Collaboration diagram for CoefClasses::CylStruct:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::CoefStruct" tooltip="CoefClasses::CoefStruct"]
"1" [label="CoefClasses::CylStruct" tooltip="CoefClasses::CylStruct" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-53ed253ec87d19a5d1a4d9cb5faf82770fd90dcc.png)
Specialization of CoefStruct for cylinders.
-
struct dark_particle
- #include <tipsydefs.h>
Tipsy particle structure for a dark particle.
-
struct dark_particle
- #include <tipsy.H>
Public Functions
-
inline int ID() const
Convert phi to index.
-
inline int ID() const
-
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"]
}](_images/graphviz-8effb1555561d42ac7682b86076c36d6092310d8.png)
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"]
}](_images/graphviz-8effb1555561d42ac7682b86076c36d6092310d8.png)
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
Private Members
-
ThreeDGridPtr ptr
-
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"]
}](_images/graphviz-4ec38595fd50a4d2493abbc023da032392b1f959.png)
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"]
}](_images/graphviz-a05e9b85e01752553cb960a6a29ea7ae262efccb.png)
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 ~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
-
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.
-
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.
-
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.
-
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
Private Functions
-
void get_dpotl(double r, double z, Eigen::MatrixXd &p, Eigen::MatrixXd &dpr, Eigen::MatrixXd &dpz, int tid)
Field evaluation members.
-
inline virtual double getRtable()
-
void initialize(void)
Initialize parameters.
-
class Disk2dHalo
- #include <Disk2dHalo.H>
Public Types
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.
Constructor: equal mass.
Constructor: multi mass.
-
void disk_eval(double R, double z, double phi, double &p, double &fr, double &fz, double &fp)
-
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)
-
inline void set_pos_origin(double &x, double &y, double &z)
-
inline void set_vel_origin(double &x, double &y, double &z)
-
double v_circ(double xp, double yp, double zp)
-
void virial_ratio(const char*, const char*)
-
double vp_disp2(double xp, double yp, double zp)
-
double vr_disp2(double xp, double yp, double zp)
-
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)
-
void table_halo_disp()
Private Members
-
int bufcnt
-
const int bunchcnt = 16384
-
double center_pos[3]
-
double center_vel[3]
-
bool com
-
bool cov
-
double dc
-
bool DF
-
std::shared_ptr<ExponentialDisk> disk
-
double dmass
-
double dP
-
double dR
-
double dr
-
double dRh
-
double dZ
-
SphericalSLptr expandh
-
std::shared_ptr<SphericalModelTable> halo
-
std::shared_ptr<SphericalModelTable> halo2
-
std::shared_ptr<SphericalModelTable> halo3
-
double hDmax
-
double hDmin
-
std::shared_ptr<SphericalModelMulti> multi
-
bool MULTI
-
vector<double> nhD
-
vector<double> nhM
-
vector<unsigned> nhN
-
int nzepi
-
int nzero
-
double scalelength
-
double sigma0
-
DiskGenType type
-
double Xmax
-
double Xmin
-
double a_drift(double xp, double yp, double zp)
-
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"]
}](_images/graphviz-9a604adf2615ffec6aaccf2cdd8895318235e8ed.png)
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"]
}](_images/graphviz-9a604adf2615ffec6aaccf2cdd8895318235e8ed.png)
Public Functions
-
inline Disk2dHaloException(const string message, const string sourcefilename, const int sourcelinenumber)
-
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"]
}](_images/graphviz-8dab393f67af9cbed0ea01bdaf6e4a3d3da0decb.png)
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"]
}](_images/graphviz-8dab393f67af9cbed0ea01bdaf6e4a3d3da0decb.png)
The usual exponential disk + a Hernquist bulge.
-
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)
-
double xmax
-
double xmin
-
bool xscl
-
class DiskHalo
- #include <DiskHalo.H>
Public Types
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)
-
DiskHalo()
Dummy 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)
-
inline void set_pos_origin(double &x, double &y, double &z)
-
inline void set_vel_origin(double &x, double &y, double &z)
-
double v_circ(double xp, double yp, double zp)
-
void virial_ratio(const char*, const char*)
-
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)
-
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)
-
void table_halo_disp()
Private Members
-
int bufcnt
-
const int bunchcnt = 16384
-
double center_pos[3]
-
double center_vel[3]
-
bool com
-
bool cov
-
double dc
-
bool DF
-
std::shared_ptr<ExponentialDisk> disk
-
double dmass
-
double dP
-
double dR
-
double dr
-
double dRh
-
double dZ
-
EmpCylSLptr expandd
-
SphericalSLptr expandh
-
std::shared_ptr<SphericalModelTable> halo
-
std::shared_ptr<SphericalModelTable> halo2
-
std::shared_ptr<SphericalModelTable> halo3
-
double hDmax
-
double hDmin
-
std::shared_ptr<SphericalModelMulti> multi
-
bool MULTI
-
vector<double> nhD
-
vector<double> nhM
-
vector<unsigned> nhN
-
int nzepi
-
int nzero
-
double scaleheight
-
double scalelength
-
double sigma0
-
DiskGenType type
-
double Xmax
-
double Xmin
-
double a_drift(double xp, double yp, double zp)
-
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"]
}](_images/graphviz-52e385ca21ac4ee7b61aa93797d159df0906917a.png)
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"]
}](_images/graphviz-52e385ca21ac4ee7b61aa93797d159df0906917a.png)
Public Functions
-
inline DiskHaloException(const string message, const string sourcefilename, const int sourcelinenumber)
-
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"]
}](_images/graphviz-c067cb0acd65334abd21f1e51a2af5d6942ef4f9.png)
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"]
}](_images/graphviz-84bdcc55f7aa4dfa74f7003f8f888bdbd604c6c1.png)
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 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
-
inline virtual double d2fde2(double E, double L) override
-
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"]
}](_images/graphviz-b36a5bb19daec7b71973d495f3dcea1528629955.png)
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"]
}](_images/graphviz-b36a5bb19daec7b71973d495f3dcea1528629955.png)
A mixture of two exponential disks.
-
struct dump
- #include <tipsydefs.h>
Tipsy file header.
-
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 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.
-
inline Dynamic2dArray()
-
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
-
inline Dynamic3dArray()
-
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"]
}](_images/graphviz-fa4efe078d759c2a06fed76391a4332eb97cb4d7.png)
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"]
}](_images/graphviz-1478ddda8af6efa80a082fc8d7dadf1fc349eb43.png)
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.
-
class EL3
- #include <Orient.H>
Class to hold energy and angular momentum for use in centering a component. Helper class for class Orient.
-
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
-
EllipForce(double a, double b, double c, double mass, int num = 100, int numr = 100)
-
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 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 Members
-
vector<double> a
-
vector<double> dX
-
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"]
}](_images/graphviz-50860745c4c1152a7a99c734e806a8d6651f75a1.png)
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"]
}](_images/graphviz-22584a2379c07873a4011f0e9a6a6e81c35b68b8.png)
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 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()
-
virtual double d2fde2(double E, double L)
-
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"]
}](_images/graphviz-4763b96b393e21bcac01dbe09ce642e2629e5361.png)
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.
Constructor with user-supplied target model.
-
double get_dens(double r, int M, int N)
Linear interpolate on grid to get density value.
-
double get_dpot(double r, int M, int N)
Linear interpolate on grid to get potential gradient (-force) value.
-
double get_potl(double r, int M, int N)
Linear interpolate on grid to get potential value.
-
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
-
inline void basisTest(bool which)
-
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"]
}](_images/graphviz-4e14ee9b7b2ef1f51cdb4c759ec5d1d719c69e15.png)
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"]
}](_images/graphviz-ffad396f3544105a50ab4ffc1598f2a12f2567f6.png)
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
-
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 vector<double> sanity()
Public Types
-
enum EmpModel
Type of density model to use.
Values:
-
enumerator Exponential
-
enumerator Gaussian
-
enumerator Plummer
-
enumerator Power
-
enumerator Deproject
-
enumerator Exponential
-
using SphModTblPtr = std::shared_ptr<SphericalModelTable>
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 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_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 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.
-
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 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 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<PCAelement> PCAelemPtr
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.
-
void compute_eof_grid(int request_id, int m)
-
void compute_even_odd(int request_id, int m)
-
double densR(double R)
-
double integral(int, int, int, int)
-
void make_grid()
-
SphModTblPtr make_sl()
-
double massR(double R)
-
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
-
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
-
struct CylCoefHeader coefheadercyl
-
MstepArray cosL
-
MstepArray cosN
-
CoefMatrix covM
-
CoefVector covV
-
double cylmass
-
bool cylmass_made
-
unsigned defSampT
-
double dfac
-
double dX
-
double dY
-
bool eof_made
-
bool EVEN_M
Suppress odd modes.
-
bool EvenOdd
Use EvenOdd partition.
-
double ffac
-
double HSCALE
-
int LMAX
-
int M
-
double maxSNR
-
double minSNR
-
int MLIM
-
int MMAX
-
int MMIN
-
int MPIbufsz
-
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
-
SLGridSphPtr ortho
-
PCAbasisPtr pb
Cache PCA information between calls.
-
double pfac
-
int rank2
-
int rank3
-
double Rtable
-
unsigned sampT
-
MstepArray sinL
-
MstepArray sinN
-
MPI_Status status
-
bool use_mpi
MPI is active.
-
pthread_mutex_t used_lock
-
double XMAX
-
double XMIN
-
double YMAX
-
double YMIN
Protected Static Functions
-
void legendre_R(int lmax, double x, Eigen::MatrixXd &p)
-
class Ensemble
- #include <phase.H>
Public Functions
-
Ensemble(int)
-
Ensemble(void)
-
inline int get_Nstars(void)
-
Ensemble integrate_to(double, freezing_function)
-
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)
-
double total_Energy(void)
-
double total_Kinetic(void)
-
double total_Potential(void)
-
double Virial(void)
-
~Ensemble(void)
-
Ensemble(int)
-
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 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 EnumBitset()
-
template<typename T>
struct EnumTraits EnumTraits must define a max data member to set the bitset size and wraps an enum class
-
class EuclideanDistance : public MSSA::KMeans::KMeansDistance
- #include <KMeans.H>
Inheritence diagram for MSSA::KMeans::EuclideanDistance:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"1" [label="MSSA::KMeans::EuclideanDistance" tooltip="MSSA::KMeans::EuclideanDistance" fillcolor="#BFBFBF"]
"2" [label="MSSA::KMeans::KMeansDistance" tooltip="MSSA::KMeans::KMeansDistance"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-d7e82e1b9f044100984341b810aad6ad85918ed3.png)
Collaboration diagram for MSSA::KMeans::EuclideanDistance:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"1" [label="MSSA::KMeans::EuclideanDistance" tooltip="MSSA::KMeans::EuclideanDistance" fillcolor="#BFBFBF"]
"2" [label="MSSA::KMeans::KMeansDistance" tooltip="MSSA::KMeans::KMeansDistance"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-d7e82e1b9f044100984341b810aad6ad85918ed3.png)
-
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"]
}](_images/graphviz-28fa6a8ca54846b8fba1b328c9a6d09f028ccc7a.png)
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"]
}](_images/graphviz-f92acc51c1bc706edaf136175238acf7cdfe4e0c.png)
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 exceptionname, const std::string message, const std::string sourcefilename, int sourcelinenumber, int errorcode = -1, bool deadlock = false)
-
class expMSSA
- #include <expMSSA.H>
Collaboration diagram for MSSA::expMSSA:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="MSSA::CoefContainer" tooltip="MSSA::CoefContainer"]
"1" [label="MSSA::expMSSA" tooltip="MSSA::expMSSA" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="usage"]
}](_images/graphviz-b4546d48a38f8982668dec76803a3f209a1193ed.png)
Class for MSSA processing of EXP coefficients along with user-specified auxiliary channels
Public Functions
-
inline void background()
Copy background coefficients to working coefficient database (e.g. for use after a zerocopy())
-
std::tuple<Eigen::VectorXd, Eigen::MatrixXd> channelDFT()
Return the frequency and power spectrum of the channel vectors for the reconstruction
See @pcDFT for intended C++ call signature and return.
-
std::tuple<Eigen::MatrixXd, Eigen::MatrixXd> contributions()
Compute the diagnostic computation of contributions per channel In C++, consider using std::tie to get the unpacked values, e.g.:
Eigen::VectorXd F; Eigen::MatrixXd G; std::tie(F, G) = contributions(); Do something with matrices F and G
-
void contributionsPNG()
Compute the diagnostic computation of contributions per channel and make image
-
expMSSA(const mssaConfig &spec, int window, int maxEV, const std::string flags = "")
Constructor
The map/dictionary has the following structure: { “mnemonic1”: (Coefs1, [ [key11], [key12], […], …]), “mnemonic2”: (Coefs2, [ [key21], [key22], […], …]),}
where the mnemonic is choosen for convenience the set of keys for each coefficient set, Coefs, specify the indices in the dimensionaly specific the the Coefs instance itself. E.g. harmonic and radial indicies for spherical and cylindrical bases.
- Parameters:
spec – map/dictionary of tuples listing the Coefs object and a list of keys
flags – is a string of YAML with changes for the default ‘ flag values
window – is the the window length
maxEV – is the maximum number of eigenvectors
-
std::tuple<Eigen::VectorXcd, Eigen::MatrixXcd> getKoopmanModes(const double tol, int window, bool debug)
Estimate Koopman modes from the trajectory eigenvectors.
-
inline std::vector<Key> getRCkeys()
Provides a list of keys for accessing the detrended reconstruction using getRC()
-
std::map<std::string, CoefClasses::CoefsPtr> getReconstructed(bool reconstructmean = true)
Get the reconstructed coefficients in an updated Coefs stuctures
The values are returned as map/dictionary with the mnemonic name as the key. You may call resetReconstructed() to get a fresh copy of the data.
-
std::map<std::string, CoefClasses::CoefsPtr> getReconstructedKoopman(int mode)
Return the reconstructed Koopman modes.
-
inline double getTotPow()
Return total power value used for normalizing coefficient series.
-
inline double getTotVar()
Return total variance value used for normalizing coefficient series.
-
std::tuple<std::vector<int>, std::vector<double>, double> kmeans(int clusters, int stride)
Get Kmeans analysis for all channels
- Parameters:
clusters – is the number of clusters to seed
stride – is the seeded strategy for initial centers
-
std::tuple<std::vector<int>, std::vector<double>, double> kmeansChannel(Key key, int clusters, int stride)
Get Kmeans analysis per channel
- Parameters:
clusters – is the number of clusters to seed
key – is the channel id vector<int>
-
void kmeansPrint(int clusters, int stride, bool toTerm = true, bool toFile = false)
Kmean analysis of the trajectories by PC with fixed cluster size Perform Kmeans analysis for a given number of clusters and print the results
- Parameters:
clusters – is the maximum number of clusters considered
stride – is the seed strategy. If positive, it is used to select initial cluster centers by stride from the PC list. If it is zero, centers are selected randomly from the PC list
toTerm – write to stdout if true
toFile – write to file if true
-
inline int numPC()
Return the number of PC vectors.
-
std::tuple<Eigen::VectorXd, Eigen::MatrixXd> pcDFT()
Return the frequency and power spectrum of the PC vectors
-
void reconstruct(const std::vector<int> &evlist)
Reconstruction for desired eigenvalues
- Parameters:
evlist – is a vector of indices correponding to the eigenvalue and PC ordering (i.e. a group). An empty list implies no PCs will be used for the reconstruction. That is, you will get the mean values or zero values for the ‘totVar’ and the ‘totPow’ options.
-
void restoreState(const std::string &prefix)
Restore current MSSA state to an HDF5 file with the given prefix.
-
void saveState(const std::string &prefix)
Save current MSSA state to an HDF5 file with the given prefix.
-
std::tuple<Eigen::VectorXd, Eigen::MatrixXd> singleDFT(const Key &key)
Return the frequency and power spectrum by PC for the selected channel
See @pcDFT for intended C++ call signature and return.
-
Eigen::MatrixXd wCorr(const std::string &name, const Key &ckey, int nPC = std::numeric_limits<int>::max())
-
Eigen::MatrixXd wCorrAll(int nPC = std::numeric_limits<int>::max())
Compute w-correlation matrix for all channels.
-
Eigen::MatrixXd wCorrKey(const Key &key, int nPC = std::numeric_limits<int>::max())
Compute w-correlation matrix for a single trajectory matrix
- Parameters:
name – is the nmemonic name (see constructor)
index – is one of the specified keys (see constructor)
-
void wcorrPNG(int nPC = std::numeric_limits<int>::max())
Create wcorrlation matricies and output PNG.
-
inline virtual ~expMSSA()
Destructor.
Protected Functions
Protected Attributes
-
CoefContainer coefDB
Coefficient container.
-
std::map<Key, std::vector<double>, mSSAkeyCompare> data
Repacked stream data.
-
double evtol
-
bool flip
Parameters.
-
bool fullRecon
-
std::map<Key, double, mSSAkeyCompare> mean
-
int ncomp
Number of components in the reconstruction.
-
std::shared_ptr<CoefContainer> newDB
Working updated copy of DB.
-
int nkeys
Number of channels.
-
int nlast = -1
Last computed number of components.
-
int nmax
-
int nmin
-
int npc
-
int numK
Columns in trajectory matrix.
-
int numT
Number of points in the time series.
-
int numW
-
YAML::Node params
Parameter database.
-
bool powerf
-
bool powFlag
-
std::map<Key, Eigen::MatrixXd, mSSAkeyCompare> RC
The reconstructed coefficients for each PC.
-
bool reconstructed
-
double totPow
-
double totVar
Normalization values.
-
bool trajectory
-
bool useMean
Toggle for detrending.
-
bool useSignChoice
-
std::map<Key, double, mSSAkeyCompare> var
-
bool varFlag
Normalization options.
-
bool verbose
-
int window
-
inline void background()
-
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"]
}](_images/graphviz-2c6e44781f62ac0136495af886c895346d95073c.png)
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"]
}](_images/graphviz-2c6e44781f62ac0136495af886c895346d95073c.png)
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)
-
inline virtual double dens(double r)
-
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"]
}](_images/graphviz-1e9abc4bad225ddb731a41ae8f728cd18d5f9b21.png)
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"]
}](_images/graphviz-1e9abc4bad225ddb731a41ae8f728cd18d5f9b21.png)
The usual exponential disk.
-
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"]
}](_images/graphviz-6670e1d65ac7c775bc42bda85b214f067fc6efb9.png)
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"]
}](_images/graphviz-14f11d23f32a9c8f2358b367da42f39bf925d09d.png)
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)
-
inline virtual double d2fde2(double E, double L)
-
class ExternalCollection
- #include <ExternalCollection.H>
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 Members
-
list<void*> dl_list
-
list<void*>::iterator itr
-
list<ExternalForce*>::iterator sitr
-
ExternalCollection()
-
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"]
}](_images/graphviz-c99e8dff1c5bf5ef1f28338e38e9a8e307cc6d83.png)
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"]
}](_images/graphviz-f8aa6b7be9919308c434788a683817f291d5140d.png)
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)
-
virtual void *determine_acceleration_and_potential_thread(void *arg) = 0
-
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"]
}](_images/graphviz-4683df12347c255fba619ac76d9fcae913caf92d.png)
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"]
}](_images/graphviz-10b28d57dc70b88d4433f5f8ea79b8333eb1b165.png)
Compute shock perturbation.
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.
-
virtual void *determine_acceleration_and_potential_thread(void *arg)
-
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.
-
inline FDIST()
-
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"]
}](_images/graphviz-396eb231ecdda3d44583729da4e68fe9cd5d65ba.png)
Chebyshev version.
Public Functions
-
inline FDISTC()
Simple constructor. Use value of num to check for initialization.
-
inline FDISTC()
-
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"]
}](_images/graphviz-d6de0457a0050ba3aafc06eccf29a1a5d2bc3419.png)
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"]
}](_images/graphviz-d6de0457a0050ba3aafc06eccf29a1a5d2bc3419.png)
A Ferrers Ellipsoid + Evacuated Exponential Disc (semi-realistic bar+disk model)
-
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"]
}](_images/graphviz-ecc6d24243461fe74457029c77007f8d10f18966.png)
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"]
}](_images/graphviz-ecc6d24243461fe74457029c77007f8d10f18966.png)
An n=2 Ferrers Ellipsoid.
-
class FieldBasis : public BasisClasses::Basis
- #include <FieldBasis.H>
Inheritence diagram for BasisClasses::FieldBasis:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"1" [label="BasisClasses::FieldBasis" tooltip="BasisClasses::FieldBasis" fillcolor="#BFBFBF"]
"3" [label="BasisClasses::VelocityBasis" tooltip="BasisClasses::VelocityBasis"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
"3" -> "1" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-64b0a743d17f9112bc0de398ebc54fc201ae1f68.png)
Collaboration diagram for BasisClasses::FieldBasis:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"1" [label="BasisClasses::FieldBasis" tooltip="BasisClasses::FieldBasis" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-dc53043122d6ca337388ee5c013b4718c1387893.png)
General basis expansion
Subclassed by BasisClasses::VelocityBasis
Public Types
Public Functions
-
virtual void accumulate(double mass, double x, double y, double z, double u, double v, double w)
Accumulate new coefficients.
-
inline virtual void accumulate(double x, double y, double z, double mass)
Accumulate new coefficients from coordinates only.
-
virtual void addFromArray(Eigen::VectorXd &m, RowMatrixXd &p, bool roundrobin = true, bool posvelrows = false)
Initialize accumulating coefficients from arrays. This is called once to initialize the accumulation.
-
void addPSFunction(PSFunction func, std::vector<std::string> &labels)
Register phase-space functionoid.
-
virtual CoefClasses::CoefStrPtr createFromReader(PR::PRptr reader, std::vector<double> center = {0.0, 0.0, 0.0})
Generate coeffients from a particle reader and optional center location for the expansion
-
inline FieldBasis(const std::string &confstr, const std::string &name = "FieldBasis")
Constructor from YAML string.
-
inline FieldBasis(const YAML::Node &conf, const std::string &name = "FieldBasis")
Constructor from YAML node.
-
BasisArray getBasis(double logxmin = -3.0, double logxmax = 0.5, int numgrid = 2000)
Return potential-density pair of a vector of a vector of 1d basis-function grids for FieldBasis, logarithmically spaced between [logxmin, logxmax] (base 10).
-
virtual CoefClasses::CoefStrPtr getCoefficients()
Retrieve the coefficients.
-
inline int getLmax()
Return current maximum harmonic order in expansion.
-
inline int getNmax()
Return current maximum order in radial expansion.
-
virtual void initFromArray(std::vector<double> center = {0.0, 0.0, 0.0})
Generate coeffients from an array and optional center location for the expansion using multiple particle partitions Initialize accumulating coefficients from arrays with an optional center vector. This is called once to initialize the accumulation.
-
virtual void make_coefs(void)
Make coefficients after accumulation.
-
inline Eigen::MatrixXd orthoCheck()
Compute the orthogonality of the basis by returning inner produce matrices
-
virtual void reset_coefs(void)
Zero out coefficients to prepare for a new expansion.
-
inline void set_scale(const double scl)
Coordinate mapping factor.
-
inline virtual ~FieldBasis(void)
Destructor.
Protected Types
Protected Functions
-
void allocateStore()
-
virtual std::vector<double> crt_eval(double x, double y, double z)
Evaluate fields in Cartesian coordinates in centered coordinate system.
-
virtual std::vector<double> cyl_eval(double r, double z, double phi)
Evaluate fields in cylindrical coordinates in centered coordinate system.
-
virtual void load_coefs(CoefClasses::CoefStrPtr coefs, double time)
Load coefficients into the new CoefStruct.
-
virtual void set_coefs(CoefClasses::CoefStrPtr coefs)
Set coefficients.
Protected Attributes
-
double ascl
-
double delta
-
int dof
-
PSFunction fieldFunc
-
int lmax
-
int nfld
Number of data fields.
-
int nmax
-
int nt
Coefficient storage.
-
double rmapping
-
double rmax
-
double rmin
Protected Static Attributes
-
virtual void accumulate(double mass, double x, double y, double z, double u, double v, double w)
-
class FieldGenerator
- #include <FieldGenerator.H>
Compute 2d slices and 3d volumes for a collection of coefficients and a given basis type.
Public Functions
-
FieldGenerator() = default
Null constructor.
-
FieldGenerator(const std::vector<double> &time, const Eigen::MatrixXd &mesh)
Constructor for an arbitrary point mesh. The mesh should be an Nx3 array
-
FieldGenerator(const std::vector<double> &time, const std::vector<double> &pmin, const std::vector<double> &pmax, const std::vector<int> &grid)
Constructor for a rectangular grid.
-
void file_lines(BasisClasses::BasisPtr basis, CoefClasses::CoefsPtr coefs, std::vector<double> beg, std::vector<double> end, int num, const std::string prefix, const std::string outdir = ".")
-
void file_slices(BasisClasses::BasisPtr basis, CoefClasses::CoefsPtr coefs, const std::string prefix, const std::string outdir = ".")
Write field slices to files. This will be VTK your build is compiled with VTK and ascii tables otherwise.
-
void file_volumes(BasisClasses::BasisPtr basis, CoefClasses::CoefsPtr coefs, const std::string prefix, const std::string outdir = ".")
Write field slices to files. This will be VTK your build is compiled with VTK and ascii tables otherwise.
-
std::tuple<Eigen::VectorXf, Eigen::VectorXf, Eigen::VectorXf> histo1dlog(PR::PRptr reader, double rmin, double rmax, int nbins, std::vector<double> center = {0.0, 0.0, 0.0})
Compute spherical log histogram from particles.
-
Eigen::VectorXf histogram1d(PR::PRptr reader, double rmax, int nbins, std::string proj, std::vector<double> center = {0.0, 0.0, 0.0})
Compute histogram from particles.
-
std::map<std::string, Eigen::MatrixXf> histogram2d(PR::PRptr reader, std::vector<double> center = {0.0, 0.0, 0.0})
Compute surface histogram from particles.
-
std::map<double, std::map<std::string, Eigen::VectorXf>> lines(BasisClasses::BasisPtr basis, CoefClasses::CoefsPtr coefs, std::vector<double> beg, std::vector<double> end, int num)
Get a field probes as a map in time and type
For example:Generate the fields for all coefficients in ‘coefs’ along the line specfied by (beg, end) where beg, end are three vectors describing points in space and num is the number of evaluations auto db = lines(basis, coefs, beg, end, num);
The code will provide three additional vectors: x, y, z, arc where x, y, z, are the evaulation positions along the line and arc describing the distance along the line from beg to end
Get an image at Time=3.14 for density (“dens”) arc = db[“3.14”][“arc”]; pot = db[“3.14”][“potl”] - db[“3.14”][“potl m=0”];
-
std::map<double, std::map<std::string, Eigen::VectorXf>> points(BasisClasses::BasisPtr basis, CoefClasses::CoefsPtr coefs)
Get field quantities at user defined points
For example:Generate the fields for all coefficients in ‘coefs’ auto db = points(basis, coefs);
Get fields evaluated at Time=3.14 and for all points in your supplied mesh for density (“dens”) Eigen::MatrixXf points = db[“3.14”][“dens”];
-
inline void setColumnHeight(double value)
Height above/below the plane for midplane search in disk scale lengths
-
inline void setMidplane(bool value)
Turn on/off midplane evaluation (only effective for disk basis and slices)
-
std::map<double, std::map<std::string, Eigen::MatrixXf>> slices(BasisClasses::BasisPtr basis, CoefClasses::CoefsPtr coefs)
Get a field slices as a map in time and type
For example:Generate the fields for all coefficients in ‘coefs’ auto db = slices(basis, coefs);
Get an image at Time=3.14 for density (“dens”) Eigen::MatrixXf surface = db[“3.14”][“dens”];
-
std::map<double, std::map<std::string, Eigen::Tensor<float, 3>>> volumes(BasisClasses::BasisPtr basis, CoefClasses::CoefsPtr coefs)
Get a field volumes as a map in time and type.
Usage as for slices but returns an Eigen::Tensor rather than an Eigen::MatrixXf.
Private Functions
-
void check_times(CoefClasses::CoefsPtr coefs)
Sanity check time vector with coefficient DB.
-
FieldGenerator() = default
-
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"]
}](_images/graphviz-7ebac59318e125800c42aee58a05ea1fb1abd13e.png)
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"]
}](_images/graphviz-7ebac59318e125800c42aee58a05ea1fb1abd13e.png)
File creation error.
-
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"]
}](_images/graphviz-2ab90fad399c6787122ca9c03adb3931fb2b387c.png)
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"]
}](_images/graphviz-2ab90fad399c6787122ca9c03adb3931fb2b387c.png)
File open error.
-
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"]
}](_images/graphviz-d0e5d70d726171aa6437e25a71aaa32febf3c388.png)
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"]
}](_images/graphviz-d0e5d70d726171aa6437e25a71aaa32febf3c388.png)
Public Functions
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
-
class FlatDisk : public BasisClasses::BiorthBasis
- #include <BiorthBasis.H>
Inheritence diagram for BasisClasses::FlatDisk:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"3" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"2" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis"]
"1" [label="BasisClasses::FlatDisk" tooltip="BasisClasses::FlatDisk" fillcolor="#BFBFBF"]
"2" -> "3" [dir=forward tooltip="public-inheritance"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-5da92c6ba15022bc138343a892d7bd8171b5cca2.png)
Collaboration diagram for BasisClasses::FlatDisk:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"3" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"2" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis"]
"1" [label="BasisClasses::FlatDisk" tooltip="BasisClasses::FlatDisk" fillcolor="#BFBFBF"]
"2" -> "3" [dir=forward tooltip="public-inheritance"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-5da92c6ba15022bc138343a892d7bd8171b5cca2.png)
Uses the BiorthCyl basis to evaluate expansion coeffients and provide potential and density basis fields
Public Types
Public Functions
-
virtual void accumulate(double x, double y, double z, double mass)
Accumulate new coefficients.
-
FlatDisk(const YAML::Node &conf)
Constructor from YAML node.
-
virtual std::vector<double> getAccel(double x, double y, double z)
Evaluate acceleration in Cartesian coordinates in centered coordinate system
-
BasisArray getBasis(double logxmin = -3.0, double logxmax = 0.5, int numgrid = 2000)
Return a vector of a vector of 1d basis-function grids for FlatDisk, logarithmically spaced between [logxmin, logxmax] (base 10).
-
inline int getMmax()
Return current maximum harmonic order in expansion.
-
inline int getNmax()
Return current maximum order in radial expansion.
-
virtual void make_coefs(void)
Make coefficients after accumulation.
-
std::vector<Eigen::MatrixXd> orthoCheck(int knots = 400)
Compute the orthogonality of the basis by returning inner produce matrices
-
inline bool orthoTest()
Biorthogonality sanity check.
-
virtual void reset_coefs(void)
Zero out coefficients to prepare for a new expansion.
-
inline virtual ~FlatDisk(void)
Destructor.
Public Static Functions
Protected Functions
-
virtual std::vector<double> crt_eval(double x, double y, double z)
Evaluate fields in Cartesian coordinates in centered coordinate system.
-
virtual std::vector<double> cyl_eval(double R, double z, double phi)
Evaluate basis in cylindrical coordinates.
-
virtual void load_coefs(CoefClasses::CoefStrPtr coefs, double time)
Load coefficients into the new CoefStruct.
-
virtual void set_coefs(CoefClasses::CoefStrPtr coefs)
Set coefficients.
Protected Static Attributes
Private Types
Private Functions
-
void initialize()
Helper for constructor.
-
virtual void accumulate(double x, double y, double z, double mass)
-
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"]
}](_images/graphviz-04c5b6d0568601ba765e34ca9344f20d33ea68b9.png)
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"]
"18" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"17" [label="CoefClasses::CylCoefs" tooltip="CoefClasses::CylCoefs"]
"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"]
"17" -> "18" [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"]
"2" -> "17" [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"]
}](_images/graphviz-3754d27837c15220cd98f9eb041468f9fa5d7867.png)
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
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.
-
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
-
double BoxSize
-
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"]
}](_images/graphviz-276e4f01030c02d4ab49ecb1b8b9ee6c6c24c19c.png)
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"]
}](_images/graphviz-276e4f01030c02d4ab49ecb1b8b9ee6c6c24c19c.png)
Public Functions
-
inline virtual unsigned long CurrentNumber()
Number of particles in the chosen type.
-
inline virtual double CurrentTime()
Get current time.
-
inline virtual unsigned long CurrentNumber()
-
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"]
}](_images/graphviz-c532dda64334576aaa300a464ff64047aae9d258.png)
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"]
}](_images/graphviz-c7de3befbd326082a946cad3c172b54925c2d13b.png)
Public Functions
-
inline virtual unsigned long CurrentNumber()
Number of particles in the chosen type.
-
inline virtual double CurrentTime()
Get current time.
-
inline virtual unsigned long CurrentNumber()
-
struct gas_particle
- #include <tipsydefs.h>
Tipsy particle structure for a gas particle.
-
struct gas_particle
- #include <tipsy.H>
Public Functions
-
inline int ID() const
Convert phi to index.
-
inline int ID() const
-
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"]
}](_images/graphviz-843fbd9a7fa90398bb253f422e2569a8bac4fb2a.png)
-
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"]
}](_images/graphviz-859d858f5b5c67b16531be080dbfb3db9494de5a.png)
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"]
}](_images/graphviz-75f2f2722ba200b4c0559a1180f1fcd7fb658cc8.png)
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&)
-
virtual double d2fde2(double E, double L)
-
class generateRelaxation : public ExternalForce
- #include <generateRelaxation.H>
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"]
}](_images/graphviz-f678019a9fcd144354de9e304e82cfac6baf2d45.png)
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"]
}](_images/graphviz-9a98d48bde58c75845f8a2d824d7de04cb08d8d3.png)
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.
-
generateRelaxation(const YAML::Node &conf)
-
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"]
}](_images/graphviz-5fa3b09fb044b44fb6a8558928f244a3fd38b92f.png)
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"]
}](_images/graphviz-5fa3b09fb044b44fb6a8558928f244a3fd38b92f.png)
Used for explicit detailed messages.
-
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"]
}](_images/graphviz-a7d964bb39b53f5f6632c0f267937d5b4ba9fdf1.png)
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"]
}](_images/graphviz-a7d964bb39b53f5f6632c0f267937d5b4ba9fdf1.png)
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
-
inline virtual double coef1(const int n)
-
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"]
}](_images/graphviz-7f8d20b9d6d013f374741f1667331909aaeb994f.png)
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"]
}](_images/graphviz-6d5f0e8b55d2c098b969b5f88c1620cacaaaa0d7.png)
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)
-
HaloBulge(const YAML::Node &conf)
-
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
-
double get_psi(double t)
Ogata mapping formula.
-
double get_psip(double t)
Derivative of the Ogata mapping formula.
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.
-
inline HankelTransform()
-
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"]
}](_images/graphviz-8259252309e7f68ab8c8d0a0a527d62e45219096.png)
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"]
}](_images/graphviz-8259252309e7f68ab8c8d0a0a527d62e45219096.png)
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)
-
inline virtual double coef1(const int n)
-
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"]
}](_images/graphviz-e6ce75bb61838bf3ae2d226247ab04ff9a069e0c.png)
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"]
}](_images/graphviz-e6ce75bb61838bf3ae2d226247ab04ff9a069e0c.png)
Public Functions
-
HermQuad(int N = 10, double ALPHA = 0.0)
-
HermQuad(int N = 10, double ALPHA = 0.0)
-
class Hernquist
- #include <models.H>
Public Functions
-
inline void set_Hernquist(double r0init, double Ginit, double Minit)
-
inline void set_Hernquist(double r0init, double Ginit, double Minit)
-
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"]
}](_images/graphviz-9e95a519d9ae58632d6a35b38f9d1769c3550d10.png)
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"]
}](_images/graphviz-e1452a2ad45b73dbd46ac7785254acb1d396c565.png)
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)
-
inline virtual double d2fde2(double E, double L)
-
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"]
}](_images/graphviz-0d54146cdf9ddb8d4b8fdd1a32d8358e8e0006e0.png)
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"]
}](_images/graphviz-0d54146cdf9ddb8d4b8fdd1a32d8358e8e0006e0.png)
Public Functions
-
virtual double d_r_to_rb(double const)
-
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 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()
-
virtual double d_r_to_rb(double const)
-
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"]
}](_images/graphviz-989a5282bcaa95b194951d5081b16eed38726bc0.png)
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"]
}](_images/graphviz-71d25bb64337992e6b15970d98c4adeb70134f31.png)
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
-
inline virtual double d2fde2(double E, double L)
-
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"]
}](_images/graphviz-fd9026f6b8a01489ba63bf935e58638229b6d138.png)
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"]
}](_images/graphviz-4a88bad2e2b4176d707ef8761298441d28cafeff.png)
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()
-
inline virtual double d2fde2(double E, double L)
-
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"]
}](_images/graphviz-946641da3dbdefc53b129fcf1b0e7dcdd7fe9007.png)
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"]
}](_images/graphviz-946641da3dbdefc53b129fcf1b0e7dcdd7fe9007.png)
This does the same thing as the non-invasive templates above using inheritance to wrap the container
-
class Info
- #include <BarrierWrapper.H>
Public Functions
-
inline Info()
Null constructor for assignment.
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.
-
inline Info()
- 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
-
class Interaction
- #include <ComponentContainer.H>
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"]
}](_images/graphviz-ce52a50a08ac78da659eae229c7a6eb3a4fa12cc.png)
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 : diskwill tell the code to apply the force from halo particles on the disk particles. The fully self-consistent simulation with adiskandhalocomponent would have the lines:halo : disk disk : halo
-
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"]
}](_images/graphviz-776f4e264abb4a3e06f33af0f68a168bf47bc80e.png)
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"]
}](_images/graphviz-776f4e264abb4a3e06f33af0f68a168bf47bc80e.png)
Used when execution reaches a point it should not reach.
-
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"]
}](_images/graphviz-2b2aad990937dfaef26435befc2827498c69c267.png)
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"]
}](_images/graphviz-2b2aad990937dfaef26435befc2827498c69c267.png)
-
class Isothermal
- #include <models.H>
Public Functions
-
inline void set_Isothermal(double r0init, double vcinit)
-
inline void set_Isothermal(double r0init, double vcinit)
-
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"]
}](_images/graphviz-5e32c5e68a354d065463358bc85d15b437447e67.png)
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"]
}](_images/graphviz-13ce464e8383bf42f3e60a3bed68f954038d67a6.png)
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)
-
inline virtual double d2fde2(double E, double L)
-
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"]
}](_images/graphviz-f21fadbb69c83ac1bf911cb3e3e60e361b71ec92.png)
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"]
}](_images/graphviz-f21fadbb69c83ac1bf911cb3e3e60e361b71ec92.png)
Public Functions
-
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"]
}](_images/graphviz-b4360054ffee4c580eaf42b4b71832b536d26574.png)
Public Types
-
using difference_type = void
-
using difference_type = void
-
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"]
}](_images/graphviz-99cade1c12570204c1b19fbe3cf3248e427fe779.png)
Subclassed by Iterable< 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"]
}](_images/graphviz-5a296b0134c9b1b95d0f62aa2d191ae768edc4f0.png)
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"]
}](_images/graphviz-fd7329566a6aae7bf76b224cfb6418dd3745ecd9.png)
Subclassed by LegeQuad
Public Functions
-
JacoQuad(int N = 10, double ALPHA = 0.0, double BETA = 0.0)
-
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"]
}](_images/graphviz-9615224b99a8de13484a55c7e21cac13d80cae89.png)
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"]
}](_images/graphviz-988aebbd488543fade99c1db1b9969c99692740d.png)
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)
-
inline virtual double d2fde2(double E, double L)
-
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
-
void kde_fft_2d()
Do the FFT convolution.
-
inline KDE2d(int numx, int numy, double xmin, double xmax, double ymin, double ymax, double sigmax, double sigmay)
-
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"]
}](_images/graphviz-139663244e01b7642a4be50bdc06f7f900e02db2.png)
k-d tree implementation
Public Types
-
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.
-
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
-
inline size_t visited() const
Returns the number of nodes visited by the last call to nearest().
Private Functions
-
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_)
-
using point_type = point<coordinate_type, dimensions>
-
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.
Private Members
-
union KeyConvert c
-
inline unsigned short C()
-
class KeyValue
- #include <cxxopts.H>
Public Functions
- inline CXXOPTS_NODISCARD const std::string & key () const
- inline CXXOPTS_NODISCARD const std::string & value () const
-
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"]
}](_images/graphviz-6cc53783c6343e98d09ca3a347150bc0ee170f53.png)
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"]
}](_images/graphviz-a56dd674fd6528bb18f68ceac8a1a2e756635afd.png)
-
class kMeansClustering
- #include <KMeans.H>
Simple implementation of Lloyd’s algorithm for arbitrary number of dimensions
Public Functions
-
inline std::vector<std::tuple<std::vector<double>, int>> get_results()
Get the vectors and center ids.
-
inline double getTol()
Get the convergence measure: the summed Euclidean distance between current centroids and previous centroids
-
void iterate(KMeansDistance &dist, int niter, int k, int s = 0, bool verbose = false)
Perform niter iterations on k means
- Parameters:
dist – is the metric distance for grouping
k – is the number of clusters to seed
s – is the stride for center seeding (s>0); random by default
verbose – true prints diagnostic info (false by default)
-
inline std::vector<std::tuple<std::vector<double>, int>> get_results()
-
class KMeansDistance
- #include <KMeans.H>
Inheritence diagram for MSSA::KMeans::KMeansDistance:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="MSSA::KMeans::EuclideanDistance" tooltip="MSSA::KMeans::EuclideanDistance"]
"1" [label="MSSA::KMeans::KMeansDistance" tooltip="MSSA::KMeans::KMeansDistance" fillcolor="#BFBFBF"]
"3" [label="MSSA::KMeans::WcorrDistMulti" tooltip="MSSA::KMeans::WcorrDistMulti"]
"4" [label="MSSA::KMeans::WcorrDistance" tooltip="MSSA::KMeans::WcorrDistance"]
"2" -> "1" [dir=forward tooltip="public-inheritance"]
"3" -> "1" [dir=forward tooltip="public-inheritance"]
"4" -> "1" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-471ea83666ce4a50576b7a82e01021fb8fa79f96.png)
Distance functor class
Subclassed by MSSA::KMeans::EuclideanDistance, MSSA::KMeans::WcorrDistMulti, MSSA::KMeans::WcorrDistance
-
class Koopman
- #include <Koopman.H>
Collaboration diagram for MSSA::Koopman:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="MSSA::CoefContainer" tooltip="MSSA::CoefContainer"]
"1" [label="MSSA::Koopman" tooltip="MSSA::Koopman" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="usage"]
}](_images/graphviz-9159938b157d31e22ec5173f0ff5008c22ef213f.png)
Class for eDMD processing of EXP coefficients along with user-specified auxiliary channels
Public Functions
-
std::tuple<Eigen::VectorXd, Eigen::MatrixXd> channelDFT()
Return the frequency and power spectrum of the channel vectors for the reconstruction
See @pcDFT for intended C++ call signature and return.
-
std::tuple<Eigen::MatrixXd, Eigen::MatrixXd> contributions()
Compute the diagnostic computation of contributions per channel In C++, consider using std::tie to get the unpacked values, e.g.:
Eigen::VectorXd F; Eigen::MatrixXd G; std::tie(F, G) = contributions(); Do something with matrices F and G
-
void contributionsPNG()
Compute the diagnostic computation of contributions per channel and make image
-
inline Eigen::MatrixXcd getModes()
Return the EDMD modes, an approximation to the Koopman eigenfunctions.
-
std::map<std::string, CoefClasses::CoefsPtr> getReconstructed()
Get the reconstructed coefficients in an updated Coefs stuctures
The values are returned as map/dictionary with the mnemonic name as the key. You may call resetReconstructed() to get a fresh copy of the data.
-
Koopman(const mssaConfig &spec, int maxEV, const std::string flags = "")
Constructor
The map/dictionary has the following structure: { “mnemonic1”: (Coefs1, [ [key11], [key12], […], …]), “mnemonic2”: (Coefs2, [ [key21], [key22], […], …]),}
where the mnemonic is choosen for convenience the set of keys for each coefficient set, Coefs, specify the indices in the dimensionaly specific the the Coefs instance itself. E.g. harmonic and radial indicies for spherical and cylindrical bases.
- Parameters:
spec – map/dictionary of tuples listing the Coefs object and a list of keys
flags – is a string of YAML with changes for the default ‘ flag values
window – is the the window length
maxEV – is the maximum number of eigenvectors
-
void reconstruct(const std::vector<int> &evlist)
Reconstruction for desired eigenvalues
- Parameters:
evlist – is a vector of indices correponding to the eigenvalue and PC ordering (i.e. a group). An empty list implies no PCs will be used for the reconstruction. That is, you will get the mean values or zero values for the ‘totVar’ and the ‘totPow’ options.
-
void restoreState(const std::string &prefix)
Restore current MSSA state to an HDF5 file with the given prefix.
-
void saveState(const std::string &prefix)
Save current MSSA state to an HDF5 file with the given prefix.
-
inline virtual ~Koopman()
Destructor.
Protected Functions
Protected Attributes
-
CoefContainer coefDB
Coefficient container.
-
bool computed
-
std::map<Key, std::vector<double>, mSSAkeyCompare> data
Repacked stream data for eDMD.
-
int nev
-
std::shared_ptr<CoefContainer> newDB
Working updated copy of DB.
-
int nkeys
Number of channels.
-
int numT
Number of points in the time series.
-
YAML::Node params
Parameter database.
-
bool powerf
-
bool project
-
bool reconstructed
-
bool verbose
Parameters.
-
std::tuple<Eigen::VectorXd, Eigen::MatrixXd> channelDFT()
-
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"]
}](_images/graphviz-bd74315063de42dee65ae339395258d377689f63.png)
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"]
}](_images/graphviz-bd74315063de42dee65ae339395258d377689f63.png)
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
-
inline virtual double dens(double R)
-
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"]
}](_images/graphviz-bc11068d81197386f709baf34f206b3062f96789.png)
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"]
}](_images/graphviz-bc11068d81197386f709baf34f206b3062f96789.png)
Public Functions
-
LaguQuad(int N = 10, double ALPHA = 0.0)
-
LaguQuad(int N = 10, double ALPHA = 0.0)
-
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"]
}](_images/graphviz-4860010fa778b81eb13585d4329fa66b202b4b03.png)
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"]
}](_images/graphviz-9b5280bee90344543e5e4b26a044252b431695ac.png)
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)
-
inline virtual double coef1(const int n)
-
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"]
}](_images/graphviz-85ac2ea595b74dc4c29f0fa64902d55bcdae6c74.png)
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"]
}](_images/graphviz-85ac2ea595b74dc4c29f0fa64902d55bcdae6c74.png)
Public Functions
-
inline LegeQuad(int N = 10)
-
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"]
}](_images/graphviz-272d757acf92c9f160569ef980d455438cd46c93.png)
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"]
}](_images/graphviz-272d757acf92c9f160569ef980d455438cd46c93.png)
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 std::vector<double> &x, const std::vector<double> &y)
Construct from std::vector input.
-
inline virtual double xhi()
-
inline virtual double xlo()
Data limits.
-
~Linear1d()
Destructor.
-
virtual double deriv(const double &x)
-
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"]
}](_images/graphviz-f0c97ce8fe5428070b1bcc645011fec66cc0a0f8.png)
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"]
}](_images/graphviz-f0c97ce8fe5428070b1bcc645011fec66cc0a0f8.png)
x = z
-
struct loadb_datum
- #include <Component.H>
Structure used to sort old & new indices for load balancing.
-
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"]
}](_images/graphviz-1b8a2c61ab4027973f80402bc2896e2d80c56aaf.png)
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"]
}](_images/graphviz-a03f9a5a0c8a67daf0a13c4c50ec42224d765750.png)
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)
-
virtual double dfde(const double E, const double V = 0.0)
-
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"]
}](_images/graphviz-4555c4a9219b1dd3ef32d343828a4e13bcd55d20.png)
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"]
}](_images/graphviz-278461edeb6c87d094b3bf88f859297729ecebaa.png)
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)
-
inline virtual double d2fde2(double E, double L)
-
class MakeModel
- #include <MakeModel.H>
-
class Mapping
- #include <EmpCyl2d.H>
Map the radius.
-
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"]
}](_images/graphviz-23bc3f75fcbf6a334f783bd1ceea1dd785e94a5c.png)
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.
-
inline void bomb(const char *s)
-
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)
-
int ncomp
-
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"]
}](_images/graphviz-2bf5be35f68f758d92c3784d9bc9cf6fcd8a9868.png)
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"]
}](_images/graphviz-bbc42c3ddc5df78191ad51955a7ca317a3d37c9b.png)
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)
-
inline virtual double dens(double R)
-
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"]
}](_images/graphviz-e36102d6afdee4ca6b86ac676ec2d9c4a65b84c4.png)
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"]
}](_images/graphviz-01faddf52ec154163d193842698a91b36d9c5c42.png)
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)
-
virtual double d2fde2(double E, double L)
-
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"]
}](_images/graphviz-fb874748c1ba2a601c8d4e6a3a48c03a11388c4b.png)
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"]
}](_images/graphviz-fb874748c1ba2a601c8d4e6a3a48c03a11388c4b.png)
-
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"]
}](_images/graphviz-d88a7496180d0443c6c9b00b75bb6bc1f77969d6.png)
-
class Miyamoto_Needle
- #include <models.H>
Public Functions
-
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(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)
-
Vector force(Vector&)
-
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"]
}](_images/graphviz-9da8431f6a8b9a584d8841542da6b48e9fe8ee9d.png)
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"]
}](_images/graphviz-9da8431f6a8b9a584d8841542da6b48e9fe8ee9d.png)
Miyamoto-Nagai disk.
-
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"]
}](_images/graphviz-858bd8664d75aaa2a23bfdf7b43d39749d8b913e.png)
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
-
virtual double pot(double r) = 0
Protected Functions
-
virtual void parse(const YAML::Node&) = 0
-
virtual double dens(double r) = 0
-
class MonotCubicInterpolator
- #include <MonotCubicInterpolator.H>
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—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.
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.
-
struct mSSAkeyCompare
- #include <CoefContainer.H>
Key comparison with length ordering.
-
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"]
}](_images/graphviz-9b1302815f9d350c92e41c9b3047617664b429e3.png)
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"]
}](_images/graphviz-9b1302815f9d350c92e41c9b3047617664b429e3.png)
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.
-
struct NData
- #include <PotAccel.H>
For timing data.
-
class Needle
- #include <models.H>
Public Functions
-
Vector force(Vector&)
-
inline double get_a(void)
-
inline double get_b(void)
-
inline double get_M(void)
-
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)
-
Vector force(Vector&)
-
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"]
}](_images/graphviz-687ad8597e215a57112c0504209488cbd9deec5a.png)
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"]
}](_images/graphviz-82e4d74cf3f05bb8cc45eb548c98b670fe6e55d4.png)
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
-
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.
-
NoForce(Component *c0, const YAML::Node &conf)
-
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"]
}](_images/graphviz-d48e5e2e2828af832ecd09c06ff0791150037ad4.png)
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"]
}](_images/graphviz-c7d2a6f5e2af55de7fa3c4ba247d532bd05071a1.png)
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
-
virtual double d_r_to_rb(double const) = 0
-
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"]
}](_images/graphviz-073771b9cfec9d16b65c96f8f481ba166f627669.png)
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"]
}](_images/graphviz-3ee9d8fde5e6ac912fb4b196b14d8d2ef80bb1a4.png)
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
-
virtual double dfde(const double, const double V = 0.0) = 0
-
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"]
}](_images/graphviz-1b53dc096d9b61bd46ae675ea425f3266fb9c391.png)
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"]
}](_images/graphviz-b1653e183daae12d2721839224373a2b3bade8fd.png)
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)
-
virtual double get_density(const double)
-
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"]
}](_images/graphviz-620d93d107353204480cd2cbff967cc11ddf2bea.png)
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"]
}](_images/graphviz-620d93d107353204480cd2cbff967cc11ddf2bea.png)
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.
-
inline virtual double d_r_to_rb(double const x)
-
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"]
}](_images/graphviz-15d7fa6ace9330771aa0957d956be556a1b95d60.png)
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"]
}](_images/graphviz-15d7fa6ace9330771aa0957d956be556a1b95d60.png)
-
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"]
}](_images/graphviz-4cd66b594d82c9313079c4bda4e3b71db4d73a7a.png)
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"]
}](_images/graphviz-4cd66b594d82c9313079c4bda4e3b71db4d73a7a.png)
-
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"]
}](_images/graphviz-82a62cbe4d09c5a69c5bcf5768566ce254850734.png)
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"]
}](_images/graphviz-82a62cbe4d09c5a69c5bcf5768566ce254850734.png)
-
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"]
}](_images/graphviz-677d10f99f26802eab72418ad918078fe788c27d.png)
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"]
}](_images/graphviz-677d10f99f26802eab72418ad918078fe788c27d.png)
-
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"]
}](_images/graphviz-1ab5c3e42cb76017ab7598c4e76ab6f007b3f213.png)
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"]
}](_images/graphviz-1ab5c3e42cb76017ab7598c4e76ab6f007b3f213.png)
-
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"]
}](_images/graphviz-13a34c5892f0a8a676b8737ab4bfb70ff4086d33.png)
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"]
}](_images/graphviz-13a34c5892f0a8a676b8737ab4bfb70ff4086d33.png)
-
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"]
}](_images/graphviz-d5f1b3f285a861b93573a2a03bff5cf72892d35a.png)
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"]
}](_images/graphviz-d5f1b3f285a861b93573a2a03bff5cf72892d35a.png)
-
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"]
}](_images/graphviz-c9f59fb7b4a59f5628b12cf69a931c7689c81d79.png)
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"]
}](_images/graphviz-c9f59fb7b4a59f5628b12cf69a931c7689c81d79.png)
-
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 CXXOPTS_NODISCARD const std::string & short_name () const
- inline CXXOPTS_NODISCARD const Value & value () const
-
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"]
}](_images/graphviz-e3321ed0af9d4abec77886a0d09fa3ea2e4fc610.png)
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"]
}](_images/graphviz-6d569dc81bb8eb787bd5721e15fe1da6bfb839d9.png)
Subclassed by cxxopts::OptionParseException, cxxopts::OptionSpecException, cxxopts::option_has_no_value_exception
Public Functions
- inline CXXOPTS_NODISCARD const char * what () const noexcept override
-
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"]
}](_images/graphviz-034e530ce2c0a7572b2e24517198f8825225e13d.png)
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"]
}](_images/graphviz-a01b70f29b35922831e2c374d9f46dd3d78946ee.png)
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
-
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 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)
Private Functions
-
inline void finalise_aliases()
Private Members
-
bool m_allow_unrecognised
-
NameHashMap m_keys = {}
-
ParsedHashMap m_parsed = {}
-
const PositionalList &m_positional
-
inline void add_to_option(OptionMap::const_iterator iter, const std::string &option, const std::string &arg)
-
class Options
- #include <cxxopts.H>
Public Functions
-
inline OptionAdder add_options(std::string group = "")
-
inline const HelpGroupDetails &group_help(const std::string &group) const
-
inline ParseResult parse(int argc, const char *const *argv)
Private Functions
-
inline OptionAdder add_options(std::string group = "")
-
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"]
}](_images/graphviz-119135a833ce5a67e59bc367742165cd09f34a6d.png)
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"]
}](_images/graphviz-f95722db8bbe54eb544695894469bcefc7ddc2cf.png)
Subclassed by cxxopts::invalid_option_format_error, cxxopts::option_exists_error
-
class OptionValue
- #include <cxxopts.H>
Public Functions
- inline CXXOPTS_NODISCARD size_t count () const noexcept
- inline CXXOPTS_NODISCARD bool has_default () const noexcept
Private Functions
-
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"]
}](_images/graphviz-278aa7bc081a9aace5aff9575561396df7f1fb54.png)
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"]
}](_images/graphviz-bd2717f3f03d0664347a62ba971595b8649b7ad1.png)
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.
-
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"]
}](_images/graphviz-29a17e9d9099789d1e4ae1117005ed6103830600.png)
Class to keep track of orientation
Log file contents:
Energy
Particles used
Current Axis(x) from regression
Current Axis(y)
Current Axis(z)
Last Axis(x) from particles
Last Axis(y)
Last Axis(z)
Current Center(x) from regression
Current Center(y)
Current Center(z)
Current Center(x) from analytic approx
Current Center(y)
Current Center(z)
Last Center(x) from particles
Last Center(y)
Last Center(z)
COM(x)
COM(y)
COM(z)
System COM(x)
System COM(y)
System COM(z)
Public Types
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 double currentAxisVar(void)
Return variance of axis determination (linear least squares solution)
-
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.
-
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.
-
~Orient()
Destructor.
Private Members
-
std::shared_ptr<PseudoAccel> accel
-
unsigned int cflags
-
int current
-
double damp
-
double deltaT
-
double Ecurr
-
double Elast
-
int keep
-
double lasttime
-
bool linear
-
string logfile
-
int many
-
int Nlast
-
unsigned int oflags
-
double sigA
-
double sigC
-
double sigCz
-
double sumX
-
double sumX2
-
int used
-
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 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
-
inline virtual ~OrthoFunction()
Destructor.
Private Functions
-
inline double d_r_to_x(double x)
-
void generate()
Generate the recursion for the orthogonal polynomials.
-
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)
-
void dumpOrtho(const std::string &filename)
-
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"]
}](_images/graphviz-a1b29aad130ed8986e63b024dd120370432951f4.png)
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
-
inline double get_a(void)
-
inline double get_b(void)
-
virtual double h(const int n) = 0
-
virtual double w(const double x) = 0
Private Members
-
double coefs[4]
-
virtual double coef1(const int n) = 0
-
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"]
}](_images/graphviz-628985ae1479e6d108f1fcaa590f994f81427961.png)
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"]
}](_images/graphviz-95e54b7f28d327d5e0988031bdb5f09dced086fa.png)
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.nwhere is begins atnbegand 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.
-
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"]
}](_images/graphviz-0fabe1953fe3b5ab8abcbeccd6061910fe5bda63.png)
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"]
}](_images/graphviz-2b7933cc674e8f60d08907464c41e0588f2a7aad.png)
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)
-
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"]
}](_images/graphviz-37f306fd65db7fcc7d0cfbe9c3ac3659a48f74da.png)
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"]
}](_images/graphviz-54cba1e34c73a29c10f18b8ff093165bf8d53237.png)
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.
-
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"]
}](_images/graphviz-64df6d3708280679518769d22ebaba3c83da63dd.png)
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"]
}](_images/graphviz-ec3fc7f423fc2fac804d526127fed7e9dc04500f.png)
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.
-
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"]
}](_images/graphviz-97279ff3800fcf376e4a48488c53afd4fc4670bb.png)
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"]
}](_images/graphviz-c4362fc02df0acc1ee3dd25a9ed2b52035011077.png)
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
-
bool native
-
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"]
}](_images/graphviz-b1b5bc6be6802d6cf0670a5776e332530564d630.png)
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"]
}](_images/graphviz-3abcd119fc2d2562f806f501b4a9cd9460227b52.png)
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.
-
OutDiag(const YAML::Node &conf)
-
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"]
}](_images/graphviz-175486c878cb62c90c8d14070b37da4592673d90.png)
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"]
}](_images/graphviz-2949428a98cde6e56888f1c0f2751f11145bb57a.png)
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.
-
class OutHDF5 : public Output
- #include <OutHDF5.H>
Inheritence diagram for OutHDF5:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"1" [label="OutHDF5" tooltip="OutHDF5" fillcolor="#BFBFBF"]
"2" [label="Output" tooltip="Output"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-6ddde6bad168f3f5a590734fdc67658ee722b3fd.png)
Collaboration diagram for OutHDF5:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"1" [label="OutHDF5" tooltip="OutHDF5" 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"]
}](_images/graphviz-35d38128708d30a5363b7c689f2fecc8064a5801.png)
Write phase-space dumps at regular intervals from each node in component pieces. This writer is indended to be Gadget-4 HDF5 compliant.
- 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 gadget:
set to true for Gadget-4-type HDF5
- Param noids:
set to true turns off particle id writing
- Param checkpt:
sets checkpoint mode: write a real8 snapshot with a unique filename
- Param preserve:
prevents overwrite of snapshot files
- Param expconfig:
set to true stashes the YAML configuration file in the HDF5 file
- Param allmeta:
set to true writes all meta data to each HDF5 file
- Param directory:
set to true stores all HDF5 files in a named directory
Public Functions
-
OutHDF5(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
noids – set to true turns off particle id writing
gadget – set to true for Gadget-4-type HDF5
checkpt – set to true for checkpoint mode
preserve – set to true prevents overwrite of snapshot files
expconfig – set to true stashes the YAML configuration file in the HDF5 file
allmeta – set to true writes all meta data to each HDF5 file
directory – set to true stores all HDF5 files in a named directory
Private Functions
-
void checkParticleMasses()
Check for single particle mass on the first invocation.
-
virtual void initialize(void)
Used to assign additional specific parameters, create storage, etc.
- 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
-
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"]
}](_images/graphviz-1404e9714182086700d437a6098324374c788d23.png)
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"]
}](_images/graphviz-200cd5abab485bce5838b93075c9c6b33cee9d50.png)
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
Current time
Total mass
Number of bodies
COM (x, y, z)
COV (x, y, z)
Ang mom (x, y, z)
Total KE
Total PE
Total E
Virial of Clausius (VC)
2T/VC
Time per step
Total particles used
For each component in succession
Total mass
Number of bodies
COM (x, y, z)
COV (x, y, z)
Ang mom (x, y, z)
Total KE
Total PE
Total E
Virial of Clausius (VC)
2T/VC
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<double> angm0
-
vector<double> angmG
-
vector<double> clausius
-
vector<double> clausius1
-
vector<double> com0
-
vector<double> comG
-
vector<double> comL
-
vector<double> cov0
-
vector<double> covG
-
vector<double> covL
-
double curwtime
-
vector<double> ektot
-
vector<double> ektot1
-
double ektotxy
-
vector<double> eptot
-
vector<double> eptot1
-
vector<double> eptotx
-
vector<double> eptotx1
-
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
-
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"]
}](_images/graphviz-c4508c9ba76902f129e9aab757a92a6948fe4aa7.png)
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"]
}](_images/graphviz-d68796756c1e27c74a6a3b2e0d1d1f68d977d785.png)
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.
-
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"]
}](_images/graphviz-43ec1770211a62eaa7e94f45f6606eec07af6348.png)
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"]
}](_images/graphviz-f6c9d6e40be78d71884fda0e0cda29f68eda384e.png)
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.
-
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"]
}](_images/graphviz-9a636c4108f59d84a0023b725654489ce23b5ff2.png)
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"]
}](_images/graphviz-a4aed3dbea409b17d62338304126432b54ba763c.png)
Write phase-space dumps at regular intervals. Each dump is written into a new file label as
filename.nwhere is begins atnbegand 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.
-
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"]
}](_images/graphviz-7ee86ead1ff9d288c9f79471cef1a7cd9266b431.png)
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"]
}](_images/graphviz-07462597ebcd71b5408704e645172b756db0f552.png)
Write phase-space dumps at regular intervals using MPI-IO
Each dump is written into a new file label as
filename.nwhere is begins atnbegand 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.
-
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"]
}](_images/graphviz-5da44a8ee986012ebe590c6df2166f8ff55e5e81.png)
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"]
}](_images/graphviz-4f0a10088618e1f36cf86e18426bd205780379e9.png)
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.nwhere is begins atnbegand 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.
-
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"]
}](_images/graphviz-e51b31aa1734f26906c408030ee9781d3a3fe00d.png)
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"]
}](_images/graphviz-d6ebf5195d7bfd7eafb7ebe9aac2dd6787d24073.png)
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.nwhere is begins atnbegand 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)
-
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="OutHDF5" tooltip="OutHDF5"]
"11" [label="OutLog" tooltip="OutLog"]
"12" [label="OutMulti" tooltip="OutMulti"]
"13" [label="OutPS" tooltip="OutPS"]
"14" [label="OutPSN" tooltip="OutPSN"]
"15" [label="OutPSP" tooltip="OutPSP"]
"16" [label="OutPSQ" tooltip="OutPSQ"]
"17" [label="OutPSR" tooltip="OutPSR"]
"18" [label="OutRelaxation" tooltip="OutRelaxation"]
"19" [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"]
"19" -> "1" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-9e15ae7e1782ac4295aea6f9955ec0d3ed4952f1.png)
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"]
}](_images/graphviz-4797ee17e179467fe4713b164bec8fb8ea89825e.png)
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, OutHDF5, 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 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.
-
Output(const YAML::Node &conf)
-
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
Private Members
-
double last
Last run time.
-
void initialize()
-
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"]
}](_images/graphviz-d750921b91ba4819c027cb5b4091c92c60a5d10d.png)
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"]
}](_images/graphviz-e0b5245b60fd58c3b796e4a303a358cfdce49aef.png)
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.
-
OutRelaxation(const YAML::Node &conf)
-
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"]
}](_images/graphviz-b4a179065689bb1a15675e92105c7da75bb1009f.png)
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"]
}](_images/graphviz-3ee7c77635223d4dbe4d956ea9618f8044a361b9.png)
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 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
-
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.
-
class ParseResult
- #include <cxxopts.H>
Public Functions
-
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)
-
ParseResult &operator=(const ParseResult&) = default
-
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"]
}](_images/graphviz-282eb150507c5d27c0ad6457965aa2968130ca30.png)
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 Functions
-
Particle()
Constructor.
-
Particle()
-
Particle(const Particle &p)
-
Particle(unsigned niatr, unsigned ndatr)
Constructor with presized attribute lists.
-
void readBinary(unsigned rsize, bool indexing, int seq, std::istream *in)
Read particles from file.
-
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.
-
Particle()
-
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.
-
inline unsigned pMemSize()
Get memory per particle.
-
inline void setLocation(int n)
Set location to the nth particle.
-
inline char *operator()()
-
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 particleUnpack(PartPtr out, char *buffer)
Unpack buffer into particle. Caller provides buffer.
-
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.
-
inline size_t getBufsize()
-
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"]
"7" [label="PR::PSPhdf5" tooltip="PR::PSPhdf5"]
"5" [label="PR::PSPout" tooltip="PR::PSPout"]
"6" [label="PR::PSPspl" tooltip="PR::PSPspl"]
"1" [label="PR::ParticleReader" tooltip="PR::ParticleReader" fillcolor="#BFBFBF"]
"8" [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"]
"7" -> "1" [dir=forward tooltip="public-inheritance"]
"5" -> "4" [dir=forward tooltip="public-inheritance"]
"6" -> "4" [dir=forward tooltip="public-inheritance"]
"8" -> "1" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-3f616a84a5050fb7633fe41afdfb6c8682b17692.png)
Base class for reading particle phase space from any simulation.
Subclassed by PR::GadgetHDF5, PR::GadgetNative, PR::PSP, PR::PSPhdf5, PR::Tipsy
Public Functions
-
virtual unsigned long CurrentNumber() = 0
Number of particles in the chosen type.
-
virtual double CurrentTime() = 0
Get current time.
-
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.
-
virtual unsigned long CurrentNumber() = 0
-
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"]
}](_images/graphviz-49e66e0128adfe3f1dc4a2e18028607f6321cd17.png)
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"]
}](_images/graphviz-49e66e0128adfe3f1dc4a2e18028607f6321cd17.png)
PCA basis structure for caching and diagnostics.
-
class PCAelement
- #include <EmpCylSL.H>
Data for each harmonic subspace.
-
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)
-
void meridional_force(double, double, double*, double*)
-
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*)
-
double dFlambda(double)
-
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"]
}](_images/graphviz-5022a94d0f5517916c6844a5d506a15dd9b36654.png)
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"]
}](_images/graphviz-1fac046d340c134ba6472457b9026aea3fd9b76e.png)
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)
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()
-
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.
-
inline size_t operator[](size_t n) const
-
class Phase
- #include <phase.H>
Public Functions
-
inline double Energy(void)
-
char *get_Integrator(void)
-
inline double get_Tolerance(void)
-
inline double get_Vscale(void)
-
inline double get_Xscale(void)
-
double Jacobi(void)
-
inline double &Mass(void)
-
Phase(void)
-
inline double &Position(int i)
-
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 double &Work(void)
Public Static Functions
-
static inline void Register_Potential(pot_func_ptr p, force_func_ptr f)
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
-
inline double Energy(void)
-
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"]
}](_images/graphviz-4c9ee0f758c67f8bfc377a9ea4b9a6562ac16d8e.png)
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"]
}](_images/graphviz-4c9ee0f758c67f8bfc377a9ea4b9a6562ac16d8e.png)
Plummer softened gravity (infinite support)
-
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"]
}](_images/graphviz-175792e941266107818e5cef2be2e7e227cb863b.png)
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"]
}](_images/graphviz-b808e4757c49bf666fbeab661e7d1f0944edc149.png)
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)
-
inline virtual double d2fde2(double E, double L)
-
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(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_
-
inline double distance(const point &pt) const
-
class Point_Quadrupole
- #include <models.H>
Public Functions
-
inline void set_Point_Quadrupole(double q)
Protected Attributes
-
double Q
-
inline void set_Point_Quadrupole(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"]
}](_images/graphviz-bfc58e7d0ccd922495b505321daaec224b91ed90.png)
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"]
"17" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"16" [label="CoefClasses::CylCoefs" tooltip="CoefClasses::CylCoefs"]
"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"]
"16" -> "17" [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"]
"1" -> "16" [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"]
}](_images/graphviz-f1916ddc2f5425de4cc72cb8e76681ddd13ceb50.png)
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
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
ifrom levelcurto levelnext
-
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
ifrom levelcurto levelnext
-
virtual void multistep_update_finish()
Execute to finish level shifts for particles.
-
PolarBasis(Component *c0, const YAML::Node &conf, MixtureBasis *m = 0)
Constructor (
linecontains 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
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_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.
-
CoefMatrix covM
-
CoefVector covV
-
CoefClasses::CylCoefs cylCoefs
Coefficient container instance for writing HDF5.
-
double cylmass
-
unsigned defSampT
-
std::vector<Eigen::MatrixXd> dpotR
Matrices per thread for obtaining derivative of potential field.
-
bool EVEN_M
Flag use of even m harmonics only.
-
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 is_flat
Model is flat.
-
double lastPlayTime
Last playback coefficient evaluation time.
-
bool M0_back
Flag fixed monopole.
-
bool M0_only
Use axisymmetric terms.
-
double maxSNR
-
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.
-
vector<double> pack
-
std::shared_ptr<CoefClasses::CylCoefs> playback
Coefficient playback instance. Using shared_ptr to avoid constructing a simple pointer or null instance
-
double rmax
The maximum radius.
-
double rmin
The minimum radius.
-
unsigned sampT
-
unsigned int seedN
Pseudorandom generation.
-
bool self_consistent
Flag self_consitency.
-
double ssfrac
Subsample fraction of particles.
-
bool subset
Flag to use subset.
-
vector<double> unpack
-
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"]
}](_images/graphviz-ae111dfcd6d75b804eb405bff33fdcb19d696fcd.png)
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"]
}](_images/graphviz-ae111dfcd6d75b804eb405bff33fdcb19d696fcd.png)
Public Functions
-
double deriv(double z)
-
double eval(double z)
-
inline int getorder(void) const
-
Poly(int)
-
Poly(int, double*)
-
Poly(void)
-
void print(ostream&)
-
~Poly(void)
Private Functions
-
void reduce_order(void)
Private Members
-
int order
-
double deriv(double z)
-
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"]
}](_images/graphviz-8e5e350487a3d2ac311d49e14a0caa7d22472e5f.png)
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"]
}](_images/graphviz-ba8ec1421e543eef5e3f34de5b1a89046ac0f0b5.png)
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
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.
-
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.
-
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
ifrom levelcurto levelnext
-
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 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 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)
-
string id
Id string.
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
Protected Functions
-
virtual void initialize(void) = 0
Used by derived class to initialize any storage and parameters.
Protected Attributes
-
bool coef_dump
Coefficient dump flag (true if a useful dump_coefs member is defined)
-
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
-
unsigned mlevel
Current level for multistepping.
-
int nbodies
Number of bodies.
Call to return
valuefor requested parametername
-
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)
-
int use_external
Set flag to add to external potential field.
-
int used
Number of particles used on last coefficient evaluation.
-
inline bool atol(string &val)
-
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"]
}](_images/graphviz-7d8d35ec5b46be1e8a254566be69566e7a67e17b.png)
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
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
-
inline std::tuple<Eigen::VectorXd, Eigen::VectorXd> getKT(std::function<double(double)> func)
-
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"]
}](_images/graphviz-0e4e2f800be2af2dba90427c8b59096afc226e72.png)
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"]
}](_images/graphviz-0e4e2f800be2af2dba90427c8b59096afc226e72.png)
-
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()
-
inline unsigned long count() const
-
class PseudoAccel
- #include <PseudoAccel.H>
-
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"]
}](_images/graphviz-84393214626e07e9cc928a48d150e4c87307ea10.png)
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"]
}](_images/graphviz-b040bd4779a73da809dedf3809ca7f68126c8962.png)
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.
-
void PrintSummary(ostream &out, bool stats = false, bool timeonly = false)
Print summary phase-space info.
-
inline PSP(bool verbose)
Default constructor.
-
inline virtual ~PSP()
Destructor.
Protected Attributes
-
MasterHeader header
-
float mtot
Temporaries for stanza statistics.
-
int pcount
-
bool VERBOSE
-
inline virtual unsigned long CurrentNumber()
-
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"]
}](_images/graphviz-f78954f5a0282793a82bfb311233762f8cc02244.png)
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"]
}](_images/graphviz-e7f123777f1accfdd981a29929a144717ab70768.png)
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.
-
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 SParticle *NextParticle() = 0
Get next particle and return null at end.
-
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.
-
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.
-
inline virtual ~PSP()
Destructor.
-
inline virtual ~PSP()
Destructor.
Public Static Functions
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.
Protected Attributes
-
MasterHeader header
-
float mtot
Temporaries for stanza statistics.
-
int pcount
-
bool VERBOSE
-
inline virtual SParticle *begin()
-
class PSPhdf5 : public PR::ParticleReader
- #include <ParticleReader.H>
Inheritence diagram for PR::PSPhdf5:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"1" [label="PR::PSPhdf5" tooltip="PR::PSPhdf5" fillcolor="#BFBFBF"]
"2" [label="PR::ParticleReader" tooltip="PR::ParticleReader"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-bdba89a88e4ef4f4756dd0c77c84df558284ff83.png)
Collaboration diagram for PR::PSPhdf5:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"1" [label="PR::PSPhdf5" tooltip="PR::PSPhdf5" fillcolor="#BFBFBF"]
"2" [label="PR::ParticleReader" tooltip="PR::ParticleReader"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-bdba89a88e4ef4f4756dd0c77c84df558284ff83.png)
Public Functions
-
inline virtual unsigned long CurrentNumber()
Number of particles in the chosen type.
-
inline virtual double CurrentTime()
Get current time.
-
inline virtual int NumFiles()
Get file cound per snapshot.
Protected Functions
-
void getInfo()
-
bool nextFile()
-
void packParticle()
-
template<typename Scalar>
void read_and_load()
-
template<typename Scalar>
void read_and_load_gadget4()
-
template<typename Scalar>
void read_and_load_psp()
-
inline virtual unsigned long CurrentNumber()
-
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"]
}](_images/graphviz-812d64e679171ec349e68c1c6eba095504147017.png)
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"]
}](_images/graphviz-d2ceaf8e188f68a531ffe6afb6f8b69b1e2c9a3d.png)
Class to access a full PSP file (OUT)
Public Functions
-
inline virtual ~PSPout()
Destructor.
Private Members
-
streampos pos
-
inline virtual ~PSPout()
-
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"]
}](_images/graphviz-2d63edad60f17574b724dcbd647c2e2811b9c12c.png)
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"]
}](_images/graphviz-45f15212404f1f0659b46811b2e53e55e7c02326.png)
Class to access a full PSP file (OUT)
-
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"]
}](_images/graphviz-f6e38b1c4ee94b476d47110fa9387e0d08f63e35.png)
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"]
}](_images/graphviz-770ed43774c165b85dd1b6ad9958480b543c0876.png)
Class to access a SPLIT PSP file (SPL)
Public Functions
-
inline virtual ~PSPspl()
Destructor.
Private Functions
-
void openNextBlob()
Open next file part.
-
inline virtual ~PSPspl()
-
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"]
}](_images/graphviz-d2d05e8f8000b1ff8e742d5397e3b63c21ff84ab.png)
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"]
}](_images/graphviz-60917aa31d9cf15e2bcada6a8f499a61945773e4.png)
Class to access a SPLIT PSP file (SPL)
Public Functions
-
virtual SParticle *GetParticle()
Reset to beginning of particles for this component.
-
virtual SParticle *NextParticle()
Get next particle and return null at end.
-
inline virtual ~PSPspl()
Destructor.
-
inline virtual ~PSPspl()
Destructor.
Private Functions
-
void openNextBlob()
Open next file part.
-
void openNextBlob()
Open next file part.
-
virtual SParticle *GetParticle()
-
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"]
}](_images/graphviz-1a45ec3984996b032f8ffd49361a574f34eaedea.png)
-
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"]
}](_images/graphviz-31519566c6b612f497a0fa87bc19e10304271c86.png)
Public Functions
-
inline bool operator==(const PSPstanza &x) const
-
inline bool operator==(const PSPstanza &x) const
-
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"]
}](_images/graphviz-388f3a5f5505fa1076ceda4dc2e99a55f478a9f9.png)
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"]
}](_images/graphviz-388f3a5f5505fa1076ceda4dc2e99a55f478a9f9.png)
Public Functions
-
inline double mu(int i)
-
inline double norm(int i)
-
PVQuad(int N = 10)
-
inline double return_pv(double lambda)
-
inline double root(int i)
-
inline double mu(int i)
-
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"]
}](_images/graphviz-adc8774eb6c748c2c280c2856837b65761f75ee6.png)
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"]
}](_images/graphviz-adc8774eb6c748c2c280c2856837b65761f75ee6.png)
A user-defined Python model.
Public Functions
-
inline virtual double operator()(double R, double z, double phi = 0.)
Density function.
-
inline virtual double operator()(double R, double z, double phi = 0.)
-
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.
-
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)
-
void check()
-
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 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
-
double Emax
-
double Emin
-
double EOFF
-
double GAMA
-
int IFAIL
-
int 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
-
double REMAX
-
double RMMAX
-
double ROFF
-
double SIGMA
-
std::shared_ptr<AxiSymModel> t
-
double TOLE
-
double TOLK
-
int verbose
-
void compute_distribution(void)
-
class Quadrupole_Bar
- #include <models.H>
Public Functions
-
inline void set_Quadrupole_Bar(double G, double Q, double length)
-
inline void set_Quadrupole_Bar(double G, double Q, double length)
-
template<typename _MatrixType>
class RedPCA - #include <RedSVD.H>
Public Types
-
typedef MatrixType::Index Index
-
typedef _MatrixType MatrixType
-
typedef MatrixType::Scalar Scalar
Public Functions
-
inline DenseMatrix components() const
-
inline void compute(const DenseMatrix &A, const Index rank)
-
inline RedPCA()
-
inline RedPCA(const MatrixType &A)
-
inline RedPCA(const MatrixType &A, const Index rank)
-
inline DenseMatrix scores() const
-
typedef MatrixType::Index Index
-
template<typename _MatrixType>
class RedSVD - #include <RedSVD.H>
Public Types
-
typedef MatrixType::Index Index
-
typedef _MatrixType MatrixType
-
typedef MatrixType::Scalar Scalar
Public Functions
-
inline void compute(const MatrixType &A, const Index rank)
-
inline DenseMatrix matrixU() const
-
inline DenseMatrix matrixV() const
-
inline RedSVD()
-
inline RedSVD(const MatrixType &A)
-
inline RedSVD(const MatrixType &A, const Index rank)
-
inline ScalarVector singularValues() const
-
typedef MatrixType::Index Index
-
template<typename _MatrixType>
class RedSymEigen - #include <RedSVD.H>
Public Types
-
typedef MatrixType::Index Index
-
typedef _MatrixType MatrixType
-
typedef MatrixType::Scalar Scalar
Public Functions
-
inline void compute(const MatrixType &A, const Index rank)
-
inline ScalarVector eigenvalues() const
-
inline DenseMatrix eigenvectors() const
-
inline RedSymEigen()
-
inline RedSymEigen(const MatrixType &A)
-
inline RedSymEigen(const MatrixType &A, const Index rank)
-
typedef MatrixType::Index Index
-
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"]
}](_images/graphviz-56772bd198a037661242cd1ed740552ac61e239d.png)
Subclassed by SphericalOrbit
-
class RGrid
Grid to hold tabulated basis.
-
class RGrid
Grid to hold tabulated basis.
-
template<typename T, typename Container = std::vector<T>, typename Iterator = typename Container::iterator>
class RingIterator - #include <Circular.H>
Public Types
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 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 bool operator==(const RingIterator &x) const
Test for equality.
-
inline RingIterator erase()
-
class RUN
- #include <massmodel.H>
A one-dimensional profile.
-
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"]
}](_images/graphviz-856696fc7a193d357a6f2e094bbd8a6f493760be.png)
-
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"]
}](_images/graphviz-bd0363c8da75e488a2d6550743d76230c01cc863.png)
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"]
}](_images/graphviz-e0a0cd3e6594bd4741bedf211faa75c77a59b14f.png)
Compute acceleration based on mean free path (dark matter pressure)
Will probably never use this again …
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.
-
virtual void *determine_acceleration_and_potential_thread(void *arg)
-
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"]
}](_images/graphviz-307cf2bfb0cb076241f5e9e31e6717a1129d4499.png)
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"]
}](_images/graphviz-307cf2bfb0cb076241f5e9e31e6717a1129d4499.png)
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 Static Attributes
-
static double HMAX
-
inline virtual double dfde(const double E, const double p)
-
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"]
}](_images/graphviz-83446f776d8c6d983dfe793ef23a15a52936ed79.png)
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"]
}](_images/graphviz-01aec1cd6364cd20efaf8d4b89a88616fcc6984e.png)
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 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)
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
-
inline virtual double dfde(const double E, const double p = 0.0)
-
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"]
}](_images/graphviz-56d4604e8e1b73ee3c67c35dd91dd79a51d924a8.png)
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"]
}](_images/graphviz-56d4604e8e1b73ee3c67c35dd91dd79a51d924a8.png)
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
-
inline virtual double dfde(const double E, const double p)
-
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"]
}](_images/graphviz-1bcf350ca731aba6ddec1aace4a02ed4294ea9e7.png)
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"]
}](_images/graphviz-1bcf350ca731aba6ddec1aace4a02ed4294ea9e7.png)
x = z/sqrt(z^2 + H^2)
-
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"]
}](_images/graphviz-11e85a23572dfa1a72daa4f6400b7207c88b382b.png)
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"]
}](_images/graphviz-ba7fbfbd73c39ef5f4c65c4c9f02e2c4b9769479.png)
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 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<double> mgrid0
-
vector<double> mgrid1
-
int nsample
-
int nselect
-
vector<double> pgrid0
-
vector<int> rcvcts
-
vector<int> rdispl
-
vector<double> rgrid0
-
vector<double> rgrid1
-
vector<int> rnumbr
-
vector<int> sdispl
-
bool self_consistent
-
vector<int> sndcts
-
vector<int> snumbr
-
int used1
-
vector<int> usedT
-
template<typename T, bool B>
struct SignedCheck
-
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 int dwell(const int d = -1)
-
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 double range(const double r = -1.0)
-
inline SimAnn()
-
inline double temperature(const double t = -1.0)
-
inline ~SimAnn()
Private Types
-
double anneal(const int iters = -1)
-
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"]
}](_images/graphviz-505b37a4b8dd6891d828e00e78e7f29bb4ec8972.png)
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"]
}](_images/graphviz-fe7b25442f89f3de0b182bf2f18b7a073cee9967.png)
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.
-
inline virtual double d2fde2(double E, double L)
-
class SingleTimeAccel : public BasisClasses::AccelFunc
- #include <BiorthBasis.H>
Inheritence diagram for BasisClasses::SingleTimeAccel:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="BasisClasses::AccelFunc" tooltip="BasisClasses::AccelFunc"]
"1" [label="BasisClasses::SingleTimeAccel" tooltip="BasisClasses::SingleTimeAccel" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-764d5bf285ea3d3ae1f6488c6b614e10af72bf10.png)
Collaboration diagram for BasisClasses::SingleTimeAccel:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="BasisClasses::AccelFunc" tooltip="BasisClasses::AccelFunc"]
"1" [label="BasisClasses::SingleTimeAccel" tooltip="BasisClasses::SingleTimeAccel" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-764d5bf285ea3d3ae1f6488c6b614e10af72bf10.png)
Evaluate acceleration for one component, return acceleration.
-
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"]
}](_images/graphviz-69d4cd01ea135b320153ef425c9defa6114490e3.png)
Compute the Hankel transform of the target density.
-
class Slab : public BasisClasses::BiorthBasis
- #include <BiorthBasis.H>
Inheritence diagram for BasisClasses::Slab:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"3" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"2" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis"]
"1" [label="BasisClasses::Slab" tooltip="BasisClasses::Slab" fillcolor="#BFBFBF"]
"2" -> "3" [dir=forward tooltip="public-inheritance"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-4d5f45e86648ede16f84edd2e60ec09b6a8f7787.png)
Collaboration diagram for BasisClasses::Slab:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"3" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"2" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis"]
"1" [label="BasisClasses::Slab" tooltip="BasisClasses::Slab" fillcolor="#BFBFBF"]
"2" -> "3" [dir=forward tooltip="public-inheritance"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-4d5f45e86648ede16f84edd2e60ec09b6a8f7787.png)
Uses the SLGridSlab basis to evaluate expansion coeffients and provide potential and density basis fields
Public Types
Public Functions
-
virtual void accumulate(double x, double y, double z, double mass)
Accumulate new coefficients.
-
virtual std::vector<double> getAccel(double x, double y, double z)
Evaluate acceleration in Cartesian coordinates in centered coordinate system
-
BasisArray getBasis(double zmin = -1.0, double zmax = 0.5, int numgrid = 2000)
Return potential-density pair of a vector of a vector of 1d basis-function grids for the SL slab, linearly spaced between [zmin, zmax]
-
virtual void make_coefs(void)
Make coefficients after accumulation.
-
std::vector<Eigen::MatrixXd> orthoCheck(int knots = 40)
Compute the orthogonality of the basis by returning inner produce matrices
-
inline bool orthoTest()
Biorthogonality sanity check.
-
virtual void reset_coefs(void)
Zero out coefficients to prepare for a new expansion.
-
Slab(const YAML::Node &conf)
Constructor from YAML node.
-
inline virtual ~Slab(void)
Destructor.
Protected Functions
-
virtual std::vector<double> crt_eval(double x, double y, double z)
Evaluate basis in Cartesian coordinates.
-
virtual std::vector<double> cyl_eval(double r, double z, double phi)
Evaluate basis in cylindrical coordinates.
-
std::tuple<double, double, double, double, double> eval(double x, double y, double z)
Evaluate field.
-
virtual void load_coefs(CoefClasses::CoefStrPtr coefs, double time)
Load coefficients into the new CoefStruct.
-
virtual void set_coefs(CoefClasses::CoefStrPtr coefs)
Set coefficients.
Protected Static Attributes
Private Functions
-
void initialize()
Initialization helper.
Private Members
-
double hslab
Scale height for slab.
-
int imx
-
int imy
-
int imz
-
int knots
Number of integration knots for orthogonal check.
-
int ngrid = 1000
SLGridSlab mesh size.
-
int nmaxx
Maximum expansion order for construction.
-
int nmaxy
-
int nmaxz
-
int nminx
Minimum expansion order for restriction.
-
int nminy
-
int nminz
-
int npart
Number of particles.
-
std::shared_ptr<SLGridSlab> ortho
Orthogonal basis instance.
-
double totalMass
Notal mass on grid.
-
std::string type = "isothermal"
Target model type for SLGridSlab.
-
unsigned used
Number of particles used to compute grid.
-
double zmax
Upper vertical bound for slab.
-
virtual void accumulate(double x, double y, double z, double mass)
-
class SlabCoefs : public CoefClasses::Coefs
- #include <Coefficients.H>
Inheritence diagram for CoefClasses::SlabCoefs:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"1" [label="CoefClasses::SlabCoefs" tooltip="CoefClasses::SlabCoefs" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-dd14e80721e3810f2dd4a20dade493b17f42b57e.png)
Collaboration diagram for CoefClasses::SlabCoefs:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"1" [label="CoefClasses::SlabCoefs" tooltip="CoefClasses::SlabCoefs" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-dd14e80721e3810f2dd4a20dade493b17f42b57e.png)
Derived class for slab coefficients
Public Functions
-
virtual void add(CoefStrPtr coef)
Add a coefficient structure to the container.
-
inline virtual void clear()
Clear coefficient container.
Compare two collections of stanzas (this is for testing only)
-
virtual std::shared_ptr<Coefs> deepcopy()
Copy all of the data; make new instances of shared pointer objects
-
void dump(int nmaxx, int nmaxy, int nmaxz)
Dump to ascii list for testing.
-
inline virtual std::shared_ptr<CoefStruct> getCoefStruct(double time)
Get coefficient structure at a given time.
-
inline std::tuple<Eigen::Tensor<std::complex<double>, 3>&, bool> interpolate(double time)
Interpolate coefficient tensor at given time.
-
inline double nmax(char d) const
Get nmax.
-
Eigen::MatrixXd &Power(char d, int min = 0, int max = std::numeric_limits<int>::max())
Get power for the coefficient DB as a function of harmonic index by dimension: x, y, z specified as a quoted char
-
inline virtual Eigen::MatrixXd &Power(int min = 0, int max = std::numeric_limits<int>::max())
Get power for the coefficient DB as a function of harmonic index. Time as rows, harmonics as columns. ‘x’ dimension by default.
- Parameters:
min – is the minimum radial order
max – is the maximum radial order
-
inline SlabCoefs(bool verbose = false)
Constructor.
-
SlabCoefs(HighFive::File &file, int stride = 1, double tmin = -std::numeric_limits<double>::max(), double tmax = std::numeric_limits<double>::max(), bool verbose = false)
H5 constructor.
-
inline virtual void zerodata()
Zero the existing data.
Protected Functions
-
virtual void readNativeCoefs(const std::string &file, int stride, double tmin, double tmax)
Read the coefficients.
-
virtual void WriteH5Params(HighFive::File &file)
Write parameter attributes.
-
virtual unsigned WriteH5Times(HighFive::Group &group, unsigned count)
Write coefficient data in H5.
-
virtual void add(CoefStrPtr coef)
-
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.
-
virtual double pot(double z) = 0
Return the potential.
Public Static Functions
-
virtual double dens(double z) = 0
-
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"]
}](_images/graphviz-4022ddac9fc3d1afdc14af5d688c12fe68cca075.png)
Collaboration diagram for SlabSL:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"10" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"9" [label="CoefClasses::SlabCoefs" tooltip="CoefClasses::SlabCoefs"]
"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"]
"9" -> "10" [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"]
"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"]
}](_images/graphviz-881df60a22ea4ba75d6dc6699208a49c1170cee2.png)
This routine computes the potential, acceleration and density using expansion periodic in X & Y and outgoing vacuum boundary condtions in Z
Public Functions
-
virtual ~SlabSL()
Destructor.
Protected Functions
-
virtual void initialize(void)
Parse parameters and initialize on first call.
Protected Static Attributes
Private Types
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
ifrom levelcurto levelnext
-
virtual void multistep_update_finish()
Execute to finish level shifts for particles.
Private Members
-
SlabSLCoefHeader coefheader
-
double dfac
-
std::vector<coefTypePtr> expccofL
-
std::vector<coefTypePtr> expccofN
-
std::shared_ptr<SLGridSlab> grid
-
double hslab
-
int imx
-
int imy
-
int imz
-
int jmax
-
int ngrid = 1000
Default number of grid points for SLGridSlab.
-
int nmaxx
-
int nmaxy
-
int nmaxz
-
int nminx
-
int nminy
-
int nnmax
-
CoefClasses::SlabCoefs slabCoefs
Coefficient container instance for writing HDF5.
-
std::string type = "isothermal"
Default slab type (must be “isothermal”, “parabolic”, or “constant”)
-
double zmax
Private Static Attributes
-
static const int ID = 1
-
virtual ~SlabSL()
-
struct SlabSLCoefHeader
Header structure for Sturm-Liouville slab expansion Used for deprecated native coefficient files
-
class SlabStruct : public CoefClasses::CoefStruct
- #include <CoefStruct.H>
Inheritence diagram for CoefClasses::SlabStruct:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::CoefStruct" tooltip="CoefClasses::CoefStruct"]
"1" [label="CoefClasses::SlabStruct" tooltip="CoefClasses::SlabStruct" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-bb3e8ac2a32aed6aac52820880633277a1fbd8a6.png)
Collaboration diagram for CoefClasses::SlabStruct:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::CoefStruct" tooltip="CoefClasses::CoefStruct"]
"1" [label="CoefClasses::SlabStruct" tooltip="CoefClasses::SlabStruct" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-bb3e8ac2a32aed6aac52820880633277a1fbd8a6.png)
Specialization of CoefStruct for a slab.
Public Types
Public Functions
-
inline void allocate()
Allocate storage arrays.
-
virtual void create()
Create an empty data storage.
-
virtual std::shared_ptr<CoefStruct> deepcopy()
Copy all of data contents to a new instance.
-
virtual bool read(std::istream &in, bool exp_type, bool verbose = false)
Read native EXP coefficients.
-
inline SlabStruct()
Constructor.
-
inline void allocate()
-
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
-
enumerator Tanh
-
using table_ptr_2D = std::shared_ptr<table_ptr_1D[]>
Private Functions
-
void bomb(string oops)
-
void compute_table_worker(void)
-
void init_table(void)
-
void mpi_setup(void)
-
void mpi_unpack_table(void)
-
bool ReadH5Cache(void)
-
void WriteH5Cache(void)
-
inline double d_xi_to_z(double x)
-
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
-
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.
Constructor with model table.
-
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
Public Static Attributes
-
static int mpi
Flag for MPI enabled (default: 0=off)
Private Functions
-
void bomb(string oops)
-
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)
-
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
-
double dfac
-
int diverge
-
double dxi
-
int lmax
-
int mpi_bufsz
-
int mpi_myid
-
int mpi_numprocs
-
int nmax
-
int numr
-
double rmap
-
double rmax
-
double rmin
-
table_ptr_1D table
-
bool tbdbg
For deep debugging.
-
double xmax
-
double xmin
-
double d_xi_to_r(double x)
-
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"]
}](_images/graphviz-f90bf900afef7d07032a1681f4eecaa4f0f9399e.png)
Abstract class for smoothing kernel. Derive all new kernels from this class.
Subclassed by PlummerSoft, SplineSoft
Public Functions
Public Members
-
const double tol = 1.0e-8
Separations smaller than this value are considered to be the same particle.
-
const double tol = 1.0e-8
-
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 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, std::list<PSPstanza>::iterator spos)
-
inline void setSize(unsigned rsize)
-
inline void setSize(unsigned rsize)
-
inline SParticle()
-
inline SParticle()
Null constructor.
-
inline SParticle()
-
inline double vel(int i)
-
inline double vel(int i)
-
void write(std::ostream &out, bool real4, size_t isiz)
Private Members
-
unsigned s
-
inline double datr(int i)
-
class SphCoefs : public CoefClasses::Coefs
- #include <Coefficients.H>
Inheritence diagram for CoefClasses::SphCoefs:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"1" [label="CoefClasses::SphCoefs" tooltip="CoefClasses::SphCoefs" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-fc90060271038f0fe727efd03cd56ec55898ab93.png)
Collaboration diagram for CoefClasses::SphCoefs:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"1" [label="CoefClasses::SphCoefs" tooltip="CoefClasses::SphCoefs" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-fc90060271038f0fe727efd03cd56ec55898ab93.png)
Derived class for spherical coefficients
Public Functions
-
virtual void add(CoefStrPtr coef)
Add a coefficient structure to the container.
-
inline virtual void clear()
Clear coefficient container.
Compare two collections of stanzas (this is for testing only)
-
virtual std::shared_ptr<Coefs> deepcopy()
Copy all of the data; make new instances of shared pointer objects
-
void dump(int lmin, int lmax, int nmin, int nmax)
Dump to ascii list for testing.
-
Eigen::Tensor<std::complex<double>, 3> getAllCoefs()
Get all coefficients indexed in l, m, n, time.
-
inline virtual std::shared_ptr<CoefStruct> getCoefStruct(double time)
Get coefficient structure at a given time.
-
inline std::tuple<Eigen::MatrixXcd&, bool> interpolate(double time)
Interpolate coefficient matrix at given time.
-
inline double lmax() const
Get lmax.
-
inline double nmax() const
Get lmax.
-
virtual Eigen::MatrixXd &Power(int min = 0, int max = std::numeric_limits<int>::max())
Get power for the coefficient DB as a function of harmonic index. Time as rows, harmonics as columns.
- Parameters:
min – is the minimum radial order
max – is the maximum radial order
-
inline SphCoefs(bool verbose = false)
Constructor.
-
inline SphCoefs(const std::string &file, int stride = 1, double tmin = -std::numeric_limits<double>::max(), double tmax = std::numeric_limits<double>::max(), bool verbose = false)
Native file constructor.
-
SphCoefs(HighFive::File &file, int stride = 0, double tmin = -std::numeric_limits<double>::max(), double tmax = std::numeric_limits<double>::max(), bool verbose = false)
H5 constructor.
-
inline virtual void zerodata()
Zero the existing data.
Protected Functions
-
virtual void readNativeCoefs(const std::string &file, int stride, double tmin, double tmax)
Read the coefficients.
-
virtual void WriteH5Params(HighFive::File &file)
Write parameter attributes.
-
virtual unsigned WriteH5Times(HighFive::Group &group, unsigned count)
Write coefficient data in H5.
-
virtual void add(CoefStrPtr coef)
-
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"]
}](_images/graphviz-36eb127ef60893def21a2e787b223802f5fd6330.png)
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"]
"14" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"13" [label="CoefClasses::SphCoefs" tooltip="CoefClasses::SphCoefs"]
"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"]
"13" -> "14" [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"]
"2" -> "13" [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"]
}](_images/graphviz-39ab11a3a17c8d8d5c8c56d2ef42ca1337275a7c.png)
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} \]whencmap=1and\[ x = \log(r) \]whencmap=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 thermin>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()
-
inline virtual double r_to_xi(double r)
Coordinate mapping.
-
inline virtual double xi_to_r(double x)
-
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"]
}](_images/graphviz-4c643a59b7a8a07b1bf8723356fdf73b37ede0b3.png)
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"]
}](_images/graphviz-227d38726b11f204db239ba42350e425d8bd3796.png)
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)
-
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)
-
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(void)
-
virtual double d_r_to_rb(double const x)
-
class Spherical : public BasisClasses::BiorthBasis
- #include <BiorthBasis.H>
Inheritence diagram for BasisClasses::Spherical:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"3" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"4" [label="BasisClasses::Bessel" tooltip="BasisClasses::Bessel"]
"2" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis"]
"1" [label="BasisClasses::Spherical" tooltip="BasisClasses::Spherical" fillcolor="#BFBFBF"]
"5" [label="BasisClasses::SphericalSL" tooltip="BasisClasses::SphericalSL"]
"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"]
}](_images/graphviz-9ad9604cd4896a846ee0841f95b0848aea53a015.png)
Collaboration diagram for BasisClasses::Spherical:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"3" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"2" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis"]
"1" [label="BasisClasses::Spherical" tooltip="BasisClasses::Spherical" fillcolor="#BFBFBF"]
"2" -> "3" [dir=forward tooltip="public-inheritance"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-5f90c47db1e285331dedb28056683d5984e4a806.png)
An abstract spherical basis to evaluate expansion coeffients and provide potential and density basis fields
Subclassed by BasisClasses::Bessel, BasisClasses::SphericalSL
Public Types
Public Functions
-
virtual void accumulate(double x, double y, double z, double mass)
Accumulate new coefficients.
-
virtual std::vector<double> getAccel(double x, double y, double z)
Evaluate acceleration in Cartesian coordinates in centered coordinate system
-
virtual BasisArray getBasis(double rmin = 0.0, double rax = 1.0, int numgrid = 2000)
Return potential-density pair of a vector of a vector of 1d basis-function grids for Spherical [rmin, rmax]
-
inline int getLmax()
Return current maximum harmonic order in expansion.
-
inline int getNmax()
Return current maximum order in radial expansion.
-
virtual void make_coefs(void)
Make coefficients after accumulation.
-
virtual std::vector<Eigen::MatrixXd> orthoCheck(int knots) = 0
Compute the orthogonality of the basis by returning inner produce matrices
-
inline bool orthoTest(int knots = 100)
Biorthogonality sanity check.
-
virtual void reset_coefs(void)
Zero out coefficients to prepare for a new expansion.
-
inline void set_scale(const double scl)
Prescaling factor.
-
inline virtual ~Spherical(void)
Destructor.
Public Static Functions
Protected Types
Protected Functions
-
virtual std::vector<double> crt_eval(double x, double y, double z)
Evaluate basis in cartesian coordinates.
-
virtual std::vector<double> cyl_eval(double R, double z, double phi)
Evaluate basis in cylindrical coordinates.
-
void initialize()
Helper for constructor.
-
virtual void load_coefs(CoefClasses::CoefStrPtr coef, double time)
Load coefficients for a particular time.
-
virtual void set_coefs(CoefClasses::CoefStrPtr coefs)
Set coefficients.
-
virtual void accumulate(double x, double y, double z, double mass)
-
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"]
}](_images/graphviz-3329ccb9462c8f5b73fd0644db177890fce0e4a6.png)
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"]
"13" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"12" [label="CoefClasses::SphCoefs" tooltip="CoefClasses::SphCoefs"]
"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"]
"12" -> "13" [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"]
"1" -> "12" [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"]
}](_images/graphviz-3d5522161533203da9f7e7966031515ab0c12b23.png)
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
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
ifrom levelcurto levelnext
-
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
ifrom levelcurto levelnext
-
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 (
linecontains 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
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_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
-
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::MatrixXd> dlegs
Matrices per thread for obtaining derivatives legendre coefficients.
-
bool EVEN_L
Flag use of even l harmonics only.
-
bool EVEN_M
Flag use of even m harmonics only.
-
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.
-
double lastPlayTime
Last playback coefficient evaluation time.
-
bool M0_only
Use axisymmetric term s.
-
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::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::shared_ptr<CoefClasses::SphCoefs> playback
Coefficient playback instance. Using shared_ptr to avoid constructing a simple pointer or null instance
-
double rmax
The maximum radius.
-
double rmin
The minimum radius.
-
unsigned int seedN
Pseudorandom generation.
-
bool self_consistent
Flag self_consitency.
-
bool setup_noise
-
CoefClasses::SphCoefs sphCoefs
Coefficient container instance for writing HDF5.
-
double ssfrac
Subsample fraction of particles.
-
bool subset
Flag to use subset.
-
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"]
}](_images/graphviz-01b1349319c291bc558913817a7ec6d520323f16.png)
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"]
}](_images/graphviz-2fb052373ea3e05476e20df8e8a898417527f270.png)
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.
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
-
inline void allowNegativeMass()
-
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"]
}](_images/graphviz-afcf7d1625e0a99ad9727311203f21d9bdf846b2.png)
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"]
}](_images/graphviz-e771cf367528e82e24be63673681fc4325eb44f4.png)
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 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()
-
virtual double d2fde2(double E, double L)
-
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"]
}](_images/graphviz-5ce3f5df9ffb4c8ae6b530cbde53ff3c6a4e9d28.png)
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"]
}](_images/graphviz-48c62ef551591bd0c36edb736091cef9b22fa3ab.png)
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.
-
double pot_trans(int l1, int l2, int n)
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(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)
Private Members
-
double am
-
struct ANGLE_GRID angle_grid
-
double ap
-
double beta
-
std::shared_ptr<AxiSymBiorth> biorth
-
double energy
-
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
-
inline double AngMom(void)
-
class SphericalSL : public BasisClasses::Spherical
- #include <BiorthBasis.H>
Inheritence diagram for BasisClasses::SphericalSL:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"4" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"3" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis"]
"2" [label="BasisClasses::Spherical" tooltip="BasisClasses::Spherical"]
"1" [label="BasisClasses::SphericalSL" tooltip="BasisClasses::SphericalSL" fillcolor="#BFBFBF"]
"3" -> "4" [dir=forward tooltip="public-inheritance"]
"2" -> "3" [dir=forward tooltip="public-inheritance"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-83ad7ac8d17faa7fa4c79511fd4602b41c4d11fd.png)
Collaboration diagram for BasisClasses::SphericalSL:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"4" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"3" [label="BasisClasses::BiorthBasis" tooltip="BasisClasses::BiorthBasis"]
"2" [label="BasisClasses::Spherical" tooltip="BasisClasses::Spherical"]
"1" [label="BasisClasses::SphericalSL" tooltip="BasisClasses::SphericalSL" fillcolor="#BFBFBF"]
"3" -> "4" [dir=forward tooltip="public-inheritance"]
"2" -> "3" [dir=forward tooltip="public-inheritance"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-83ad7ac8d17faa7fa4c79511fd4602b41c4d11fd.png)
Uses SLGridSph basis to evaluate expansion coeffients and provide potential and density basis fields
Public Functions
-
virtual BasisArray getBasis(double logxmin = -3.0, double logxmax = 0.5, int numgrid = 2000)
Return potential-density pair of a vector of a vector of 1d basis-function grids for SphericalSL, logarithmically spaced between [logxmin, logxmax] (base 10).
-
inline virtual std::vector<Eigen::MatrixXd> orthoCheck(int knots = 40)
Compute the orthogonality of the basis by returning inner produce matrices
-
SphericalSL(const YAML::Node &conf)
Constructor from YAML node.
-
inline virtual ~SphericalSL(void)
Destructor.
Protected Functions
-
void initialize()
Helper for constructor.
Protected Attributes
-
std::shared_ptr<SphericalModelTable> mod
-
virtual BasisArray getBasis(double logxmin = -3.0, double logxmax = 0.5, int numgrid = 2000)
-
class SphericalSL
- #include <SphericalSL.H>
Public Functions
-
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)
-
inline int get_maxNL(void)
-
inline int get_maxNR(void)
-
inline void get_potl_dens(int l, int n, double r, int id = 0)
-
inline void set_compute()
-
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 initialize(void)
-
void determine_fields_at_point(double r, double theta, double phi, double *tdens, double *tpotl, double *tpotr, double *tpott, double *tpotp, int id = 0)
-
class SphFldCoefs : public CoefClasses::Coefs
- #include <Coefficients.H>
Inheritence diagram for CoefClasses::SphFldCoefs:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"1" [label="CoefClasses::SphFldCoefs" tooltip="CoefClasses::SphFldCoefs" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-85886e84f93fd4bbc70457c6f4d99e18063f73c0.png)
Collaboration diagram for CoefClasses::SphFldCoefs:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"1" [label="CoefClasses::SphFldCoefs" tooltip="CoefClasses::SphFldCoefs" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-85886e84f93fd4bbc70457c6f4d99e18063f73c0.png)
Derived class for spherical field coefficients
Public Functions
-
virtual void add(CoefStrPtr coef)
Add a coefficient structure to the container.
-
inline virtual void clear()
Clear coefficient container.
Compare two collections of stanzas (this is for testing only)
-
virtual std::shared_ptr<Coefs> deepcopy()
Copy all of the data; make new instances of shared pointer objects
-
Eigen::Tensor<std::complex<double>, 4> getAllCoefs()
Get all coefficients indexed in index, l, m, n, time.
-
inline virtual std::shared_ptr<CoefStruct> getCoefStruct(double time)
Get coefficient structure at a given time.
-
SphFldStruct::dataType getMatrix(double time)
Operator for pyEXP.
-
inline std::tuple<SphFldStruct::coefType&, bool> interpolate(double time)
Interpolate coefficient matrix at given time.
-
inline double lmax() const
Get lmax.
-
inline double nfld() const
Get number of data fields.
-
inline double nmax() const
Get lmax.
-
virtual Eigen::MatrixXd &Power(int min = 0, int max = std::numeric_limits<int>::max())
Get power for the coefficient DB as a function of harmonic index. Time as rows, harmonics as columns.
- Parameters:
min – is the minimum radial order
max – is the maximum radial order
-
void setMatrix(double time, SphFldStruct::dataType &mat)
Natural data setter for pyEXP.
-
inline SphFldCoefs(bool verbose = false)
Constructor.
-
SphFldCoefs(const YAML::Node &conf, bool verbose)
YAML onstructor.
-
SphFldCoefs(HighFive::File &file, int stride = 0, double tmin = -std::numeric_limits<double>::max(), double tmax = std::numeric_limits<double>::max(), bool verbose = false)
H5 constructor.
-
inline SphFldCoefs(SphFldCoefs &p)
Copy constructor.
-
inline virtual void zerodata()
Zero the existing data.
Protected Functions
-
inline virtual void readNativeCoefs(const std::string &file, int stride, double tmin, double tmax)
Read the coefficients.
-
virtual void WriteH5Params(HighFive::File &file)
Write parameter attributes.
-
virtual unsigned WriteH5Times(HighFive::Group &group, unsigned count)
Write coefficient data in H5.
-
virtual void add(CoefStrPtr coef)
-
class SphFldStruct : public CoefClasses::CoefStruct
- #include <CoefStruct.H>
Inheritence diagram for CoefClasses::SphFldStruct:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::CoefStruct" tooltip="CoefClasses::CoefStruct"]
"1" [label="CoefClasses::SphFldStruct" tooltip="CoefClasses::SphFldStruct" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-b5787ffeb014d916835544f02e6ff4f6d05c68d3.png)
Collaboration diagram for CoefClasses::SphFldStruct:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::CoefStruct" tooltip="CoefClasses::CoefStruct"]
"1" [label="CoefClasses::SphFldStruct" tooltip="CoefClasses::SphFldStruct" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-b5787ffeb014d916835544f02e6ff4f6d05c68d3.png)
Specialization of CoefStruct for spheres for general fields.
Public Types
Public Functions
-
inline void allocate()
Allocate storage arrays.
-
virtual void create()
Create an empty data storage.
-
virtual std::shared_ptr<CoefStruct> deepcopy()
Copy all of data contents to a new instance.
-
virtual bool read(std::istream &in, bool exp_type, bool verbose = false)
Read native EXP coefficients.
-
inline SphFldStruct()
Constructor.
-
inline void allocate()
-
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)
-
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.
-
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 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 void set_scale(const double scl)
Prescaling factor.
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
Private Functions
-
void bomb(char *s)
-
void accumulate(double x, double y, double z, double mass)
-
class SphStruct : public CoefClasses::CoefStruct
- #include <CoefStruct.H>
Inheritence diagram for CoefClasses::SphStruct:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::CoefStruct" tooltip="CoefClasses::CoefStruct"]
"1" [label="CoefClasses::SphStruct" tooltip="CoefClasses::SphStruct" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-716ae014d82a8be21ef44397a97524ffb0fd8eb8.png)
Collaboration diagram for CoefClasses::SphStruct:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::CoefStruct" tooltip="CoefClasses::CoefStruct"]
"1" [label="CoefClasses::SphStruct" tooltip="CoefClasses::SphStruct" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-716ae014d82a8be21ef44397a97524ffb0fd8eb8.png)
Specialization of CoefStruct for spheres.
Public Functions
-
inline void allocate()
Allocate storage arrays.
-
virtual void create()
Create an empty data storage.
-
virtual std::shared_ptr<CoefStruct> deepcopy()
Copy all of data contents to a new instance.
-
virtual bool read(std::istream &in, bool exp_type, bool verbose = false)
Read native EXP coefficients.
-
inline SphStruct()
Constructor.
-
inline void allocate()
-
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"]
}](_images/graphviz-602f10f78a840f45e68a0b73c82ff492fbd444b8.png)
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"]
}](_images/graphviz-602f10f78a840f45e68a0b73c82ff492fbd444b8.png)
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()
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.
-
virtual double deriv(const double &x)
-
class Spline2d
- #include <interp.H>
Two dimensional spline interpolator.
Public Functions
-
double eval(const double &x, const double &y)
Evaluate the interpolant.
-
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
-
double eval(const double &x, const double &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"]
}](_images/graphviz-05bf4d41a42b7a8a59b7e13a3b08452ecf5fa4fa.png)
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"]
}](_images/graphviz-05bf4d41a42b7a8a59b7e13a3b08452ecf5fa4fa.png)
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.
-
virtual std::pair<double, double> operator()(double r, double eps)
- 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
-
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.
Private Members
-
MPI_Datatype Particletype
-
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"]
}](_images/graphviz-7630383e01968d888a2c713f05c4da270f49acf2.png)
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"]
}](_images/graphviz-7630383e01968d888a2c713f05c4da270f49acf2.png)
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"]
}](_images/graphviz-2cde5cf1820e831e28a134fffd4e895ce442e52e.png)
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"]
}](_images/graphviz-2cde5cf1820e831e28a134fffd4e895ce442e52e.png)
Public Functions
-
inline standard_value()
-
inline explicit standard_value(bool *b)
-
~standard_value() override = default
Private Functions
-
inline void set_default_and_implicit()
-
inline standard_value()
-
struct star_particle
- #include <tipsydefs.h>
Tipsy particle structure for a star particle.
-
struct star_particle
- #include <tipsy.H>
Public Functions
-
inline int ID() const
Convert phi to index.
-
inline int ID() const
-
class StatsMPI
- #include <StatsMPI.H>
A class for accumulating data and computing rate coefficients from the DSMC simulation distribution.
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
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
-
inline void add(const speciesKey &k, double wgt, double val)
-
template<class T>
class StringTok - #include <StringTok.H>
Public Functions
-
class TableCyl
- #include <sltableMP2.H>
-
class TableData : public CoefClasses::Coefs
- #include <Coefficients.H>
Inheritence diagram for CoefClasses::TableData:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"1" [label="CoefClasses::TableData" tooltip="CoefClasses::TableData" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-81c88dd9d22523c7dc455114d3f1d792af57eff3.png)
Collaboration diagram for CoefClasses::TableData:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"1" [label="CoefClasses::TableData" tooltip="CoefClasses::TableData" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-81c88dd9d22523c7dc455114d3f1d792af57eff3.png)
Derived class for a table of data
Public Functions
-
virtual void add(CoefStrPtr coef)
Add a coefficient structure to the container.
-
inline virtual void clear()
Clear coefficient container.
Compare two collections of stanzas (this is for testing only)
-
virtual std::shared_ptr<Coefs> deepcopy()
Copy all of the data; make new instances of shared pointer objects. This will recursively call the deepcopy() functions or all dependent objects
-
inline virtual std::shared_ptr<CoefStruct> getCoefStruct(double time)
Get coefficient structure at a given time.
-
inline virtual Eigen::MatrixXd &Power(int min = 0, int max = std::numeric_limits<int>::max())
Get power for the series. Not implemented meaningfully for table data.
-
virtual void setData(double time, Eigen::VectorXcd &arr)
Set coefficient matrix at given time. This is for pybind11, since the operator() will not allow lvalue assignment, it seems.
-
inline TableData(bool verbose = false)
Constructor.
-
TableData(const std::vector<double> &time, const std::vector<std::vector<double>> &data, bool verbose = false)
Constructor from vectors.
-
TableData(HighFive::File &file, int stride = 1, double tmin = -std::numeric_limits<double>::max(), double tmax = std::numeric_limits<double>::max(), bool verbose = false)
H5 constructor.
-
inline virtual void zerodata()
Zero the existing data.
Protected Functions
-
virtual void readNativeCoefs(const std::string &file, int stride, double tmin, double tmax)
Read the coefficients.
-
virtual void WriteH5Params(HighFive::File &file)
Write parameter attributes.
-
virtual unsigned WriteH5Times(HighFive::Group &group, unsigned count)
Write coefficient data in H5.
-
virtual void add(CoefStrPtr coef)
-
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"]
}](_images/graphviz-859c900a4850491139af17170f303ef90aeb20fc.png)
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"]
}](_images/graphviz-859c900a4850491139af17170f303ef90aeb20fc.png)
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
-
TableGrid(int nx, int ny, int nz, double xmin, double xmax, double ymin, double ymax, double zmin, double zmax)
Constructor.
-
TableGrid(int nx, int ny, int nz, double xmin, double xmax, double ymin, double ymax, double zmin, double zmax)
-
class TableSlab
- #include <sltableMP2.H>
-
class TableSph
- #include <sltableMP2.H>
-
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"]
}](_images/graphviz-a7289260effe17404f7459caa1be0dc7a4f9a6a2.png)
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"]
}](_images/graphviz-a7289260effe17404f7459caa1be0dc7a4f9a6a2.png)
x = tanh(z/H)
-
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"]
}](_images/graphviz-8e87fd1ee3a35d4661c14a240eef46932a770ad1.png)
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"]
}](_images/graphviz-f1216c844aeb524652b91fd5bffc46e065432432.png)
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.
-
virtual double d2fde2(double E, double L)
-
class TblStruct : public CoefClasses::CoefStruct
- #include <CoefStruct.H>
Inheritence diagram for CoefClasses::TblStruct:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::CoefStruct" tooltip="CoefClasses::CoefStruct"]
"1" [label="CoefClasses::TblStruct" tooltip="CoefClasses::TblStruct" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-b9403e5d44f704248db9da6ffc50a4ebe5d310c2.png)
Collaboration diagram for CoefClasses::TblStruct:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::CoefStruct" tooltip="CoefClasses::CoefStruct"]
"1" [label="CoefClasses::TblStruct" tooltip="CoefClasses::TblStruct" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-b9403e5d44f704248db9da6ffc50a4ebe5d310c2.png)
Specialization of CoefStruct for a data table.
-
struct thrd_pass_posvel
- #include <global.H>
Helper class to pass info for incr_postion and incr_velocity.
-
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"]
}](_images/graphviz-1de7b0c7b28338264792d538ae6ca188730d6874.png)
Helper class to pass info to threaded member.
-
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"]
}](_images/graphviz-c300e5c9de13008a4c3a294c0412264fa25ba1a0.png)
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 Add(const std::vector<double> &data, const std::string &name) = 0
-
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"]
}](_images/graphviz-7020d44ed4be49ef8b93d46cbe666e7a42414e81.png)
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"]
}](_images/graphviz-155b835445019b18df7fdb40b51ab0e25c6401c3.png)
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.
-
tidalField(const YAML::Node &config)
-
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
-
inline Time(double T)
-
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 double getTime()
-
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"]
}](_images/graphviz-de0866557b15d2e4a5d5f557c009d24d18543591.png)
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"]
}](_images/graphviz-83e282d02c2e05b2e580af34b0b7e7524f657b06.png)
Class to access a Tipsy file
Public Functions
-
virtual unsigned long CurrentNumber()
Number of particles in the chosen type.
-
inline virtual double CurrentTime()
Get current time.
-
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 Static Attributes
-
virtual unsigned long CurrentNumber()
-
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"]
}](_images/graphviz-ed569d2f2cf558529a38e8f480ee191099bb5ea6.png)
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"]
}](_images/graphviz-a3f8f181e32a22b337df39ba2ee892d1cc18b6f4.png)
Subclassed by TipsyReader::TipsyNative
Public Members
-
std::vector<dark_particle> dark_particles
-
std::vector<gas_particle> gas_particles
-
std::vector<star_particle> star_particles
-
std::vector<dark_particle> dark_particles
-
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"]
}](_images/graphviz-b728541c507fa025691b50fe472b054664864c4b.png)
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"]
}](_images/graphviz-c6a3fc03611afd358c3fbc733cd021eb760d4e45.png)
Private Functions
-
inline int native_header()
Read the header.
-
inline int native_read()
-
inline virtual void read_dark()
-
inline virtual void read_gas()
-
inline virtual void read_star()
Friends
- friend class PR::Tipsy
-
inline int native_header()
-
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"]
}](_images/graphviz-1298892187c5b0927c99ddf3498eeb445ba1a8b9.png)
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"]
}](_images/graphviz-717ef9d3117edc91ef410fef8023f46c943b6ec8.png)
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)
-
virtual double d2fde2(double E, double L)
-
class TrajectoryData : public CoefClasses::Coefs
- #include <Coefficients.H>
Inheritence diagram for CoefClasses::TrajectoryData:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"1" [label="CoefClasses::TrajectoryData" tooltip="CoefClasses::TrajectoryData" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-0330824577e805f73e9b5dbf27d644d4e9c65365.png)
Collaboration diagram for CoefClasses::TrajectoryData:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"1" [label="CoefClasses::TrajectoryData" tooltip="CoefClasses::TrajectoryData" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-0330824577e805f73e9b5dbf27d644d4e9c65365.png)
Derived class for a collection of trajectories
Public Functions
-
virtual void add(CoefStrPtr coef)
Add a coefficient structure to the container.
-
inline virtual void clear()
Clear coefficient container.
Compare two collections of stanzas (this is for testing only)
-
virtual std::shared_ptr<Coefs> deepcopy()
Copy all of the data; make new instances of shared pointer objects. This will recursively call the deepcopy() functions or all dependent objects
-
inline virtual std::shared_ptr<CoefStruct> getCoefStruct(double time)
Get coefficient structure at a given time.
-
inline virtual Eigen::MatrixXd &Power(int min = 0, int max = std::numeric_limits<int>::max())
Get power for the series. Not implemented meaningfully for trajctory data.
-
virtual void setData(double time, Eigen::VectorXcd &arr)
Set coefficient matrix at given time. This is for pybind11, since the operator() will not allow lvalue assignment, it seems.
-
inline TrajectoryData(bool verbose = false)
Constructor.
-
TrajectoryData(const std::vector<double> &time, const std::vector<Eigen::MatrixXd> &data, bool verbose = false)
Constructor from vectors.
-
TrajectoryData(HighFive::File &file, int stride = 1, double tmin = -std::numeric_limits<double>::max(), double tmax = std::numeric_limits<double>::max(), bool verbose = false)
H5 constructor.
-
inline TrajectoryData(TrajectoryData &p)
Copy constructor.
-
inline virtual void zerodata()
Zero the existing data.
Protected Functions
-
virtual void readNativeCoefs(const std::string &file, int stride, double tmin, double tmax)
Read the coefficients.
-
virtual void WriteH5Params(HighFive::File &file)
Write parameter attributes.
-
virtual unsigned WriteH5Times(HighFive::Group &group, unsigned count)
Write coefficient data in H5.
-
virtual void add(CoefStrPtr coef)
-
class TrajStruct : public CoefClasses::CoefStruct
- #include <CoefStruct.H>
Inheritence diagram for CoefClasses::TrajStruct:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::CoefStruct" tooltip="CoefClasses::CoefStruct"]
"1" [label="CoefClasses::TrajStruct" tooltip="CoefClasses::TrajStruct" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-eabed6a94c496bc9bbd5b9f4814d75f486125ae7.png)
Collaboration diagram for CoefClasses::TrajStruct:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="CoefClasses::CoefStruct" tooltip="CoefClasses::CoefStruct"]
"1" [label="CoefClasses::TrajStruct" tooltip="CoefClasses::TrajStruct" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-eabed6a94c496bc9bbd5b9f4814d75f486125ae7.png)
Specialization of CoefStruct for collection of trajectories.
-
class TransformFFT
- #include <TransformFFT.H>
Public Functions
-
~TransformFFT()
-
~TransformFFT()
-
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"]
}](_images/graphviz-162477112a19b2e1f3cbff34d4cbc83aa6fa2ad3.png)
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"]
}](_images/graphviz-162477112a19b2e1f3cbff34d4cbc83aa6fa2ad3.png)
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)
-
inline virtual double operator()(double R, double z, double phi = 0.)
-
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"]
}](_images/graphviz-f608fa5a9becfb51ade9c2552e5b860b383db48e.png)
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"]
}](_images/graphviz-b71e670f8049ddfbb225d6b5fbac4047a04ca086.png)
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 Functions
-
inline double Cmixture(double *p)
The complement of the mixture function, also in [0,1].
-
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
ifrom levelcurto levelnext
-
inline virtual void multistep_update_finish()
Execute to finish level shifts for particles.
-
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
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)
-
MixtureBasis *mix_in
Mixture containers for each basis.
-
MixtureBasis *mix_out
-
class TwoDCoefs
- #include <TwoDCoefs.H>
Public Types
Public Functions
-
template<typename T>
struct type_is_container - #include <cxxopts.H>
Public Static Attributes
-
static constexpr bool value = false
-
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
-
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"]
}](_images/graphviz-7b9f95b7bef680d76f6adf70169455b8f65615fc.png)
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"]
}](_images/graphviz-7b9f95b7bef680d76f6adf70169455b8f65615fc.png)
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
-
inline virtual double coef1(const int n)
-
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"]
}](_images/graphviz-4a76a12473ad93d1217ac893b474a372ce25542d.png)
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"]
}](_images/graphviz-56a81bf0c92c93457048708a7d7891c9d04498b9.png)
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
erfturn on- Param Toff:
is the time at the center of the
erfturn 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
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
-
double b5
-
double bratio
-
double cratio
-
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
-
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"]
}](_images/graphviz-22591d7cd16e3f05a63861d2697aadca45671a30.png)
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"]
}](_images/graphviz-28fcf183b6a78d7e6489b7eb38ab6d69195bcd6d.png)
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
erfturn on- Param Toff:
is the time at the center of the
erfturn 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
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()
-
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"]
}](_images/graphviz-dbc5cbab7ee634110b34b8de41131a223c4237fa.png)
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"]
}](_images/graphviz-3b9962e2661b6d8ecf9fd1cafa02f89b114a8265.png)
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)
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()
-
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"]
}](_images/graphviz-94e86aab54942e80d0115bf2146197897bb1c6e3.png)
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"]
}](_images/graphviz-0695ab6bcd35a51d4af2e5ed064c78859c8c25f8.png)
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)
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()
-
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"]
}](_images/graphviz-714902cffe39e652f69acd705933d7632f8491be.png)
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"]
}](_images/graphviz-abcea6e8a820b84426c61fc3548201b754c0804b.png)
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
erfturn on- Param Toff:
is the time at the center of the
erfturn 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)
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()
-
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"]
}](_images/graphviz-5f4934fc246b02f8c31a9e31f982cd9415fa6b2e.png)
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"]
}](_images/graphviz-134acfa8e8981583407663831ca820b9a185f7e0.png)
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
erfturn on- Param Toff:
is the time at the center of the
erfturn 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)
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()
-
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"]
}](_images/graphviz-615ff46385aa9eb7344a0577d3efcca0101411ff.png)
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"]
}](_images/graphviz-c0cbac1e669348de49eaced4791097fc5a8c51bf.png)
Simple skeleton user routine Does nothing but print out messages at each call
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.
-
virtual void *determine_acceleration_and_potential_thread(void *arg)
-
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"]
}](_images/graphviz-277525e8535e76d8f81bacc5456c3f2dde76f7e4.png)
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"]
}](_images/graphviz-35928b60836b58f5f0cc720094b944ac00878424.png)
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.
-
virtual void *determine_acceleration_and_potential_thread(void *arg)
-
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"]
}](_images/graphviz-cb8c42a43741797fd2e5522ee2c1c61e0424e572.png)
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"]
}](_images/graphviz-5daf226a819f23a65157dd7935a88d7491b4eef1.png)
Subclassed by cxxopts::values::abstract_value< bool >, cxxopts::values::abstract_value< T >
-
class VelocityBasis : public BasisClasses::FieldBasis, public BasisClasses::Basis
- #include <FieldBasis.H>
Inheritence diagram for BasisClasses::VelocityBasis:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"3" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"2" [label="BasisClasses::FieldBasis" tooltip="BasisClasses::FieldBasis"]
"1" [label="BasisClasses::VelocityBasis" tooltip="BasisClasses::VelocityBasis" fillcolor="#BFBFBF"]
"2" -> "3" [dir=forward tooltip="public-inheritance"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
"1" -> "3" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-68e027ce839543e26caf1fdaebff71c533028222.png)
Collaboration diagram for BasisClasses::VelocityBasis:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"3" [label="BasisClasses::Basis" tooltip="BasisClasses::Basis"]
"2" [label="BasisClasses::FieldBasis" tooltip="BasisClasses::FieldBasis"]
"1" [label="BasisClasses::VelocityBasis" tooltip="BasisClasses::VelocityBasis" fillcolor="#BFBFBF"]
"2" -> "3" [dir=forward tooltip="public-inheritance"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
"1" -> "3" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-68e027ce839543e26caf1fdaebff71c533028222.png)
Velocity basis expansion
Public Types
Public Functions
-
virtual void accumulate(double mass, double x, double y, double z, double u, double v, double w)
Accumulate new coefficients.
-
BasisArray getBasis(double logxmin = -3.0, double logxmax = 0.5, int numgrid = 2000)
Return potential-density pair of a vector of a vector of 1d basis-function grids for VelocityBasis, logarithmically spaced between [logxmin, logxmax] (base 10).
-
virtual CoefClasses::CoefStrPtr getCoefficients()
Retrieve the coefficients.
-
inline int getLmax()
Return current maximum harmonic order in expansion.
-
inline int getNmax()
Return current maximum order in radial expansion.
-
virtual void make_coefs(void)
Make coefficients after accumulation.
-
virtual void reset_coefs(void)
Zero out coefficients to prepare for a new expansion.
-
inline void set_scale(const double scl)
Prescaling factor.
-
VelocityBasis(const std::string &confstr)
Constructor from YAML string.
-
VelocityBasis(const YAML::Node &conf)
Constructor from YAML node.
-
VelocityBasis(const YAML::Node &conf)
Constructor from YAML node.
-
inline virtual ~VelocityBasis(void)
Destructor.
Protected Functions
-
virtual std::vector<double> crt_eval(double x, double y, double z)
Evaluate fields in Cartesian coordinates in centered coordinate system.
-
virtual std::vector<double> cyl_eval(double r, double z, double phi)
Evaluate fields in cylindrical coordinates in centered coordinate system.
-
virtual void load_coefs(CoefClasses::CoefStrPtr coefs, double time)
Load coefficients into the new CoefStruct.
-
virtual void set_coefs(CoefClasses::CoefStrPtr coefs)
Set coefficients.
Protected Static Attributes
Private Types
Private Members
-
double ascl
-
CoefClasses::CoefStrPtr coefstr
-
double delta
-
int dof
-
int lmax
-
int nmax
-
std::shared_ptr<OrthoFunction> ortho
-
double rmax
-
double rmin
-
double scale
-
int used
-
virtual void accumulate(double mass, double x, double y, double z, double u, double v, double w)
-
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"]
}](_images/graphviz-0bfb6d47f19d2598cbcf078c3f2c1b4cb2704b36.png)
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"]
}](_images/graphviz-0bfb6d47f19d2598cbcf078c3f2c1b4cb2704b36.png)
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.
Private Functions
-
virtual void Add(const std::vector<double> &data, const std::string &name)
-
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.
Private Members
-
std::vector<vtkFloatArrayP> coef
-
std::vector<vtkFloatArrayP> covr
-
vtkRectilinearGridP dataSet
-
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
-
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)
-
class WcorrDistance : public MSSA::KMeans::KMeansDistance
- #include <KMeans.H>
Inheritence diagram for MSSA::KMeans::WcorrDistance:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="MSSA::KMeans::KMeansDistance" tooltip="MSSA::KMeans::KMeansDistance"]
"1" [label="MSSA::KMeans::WcorrDistance" tooltip="MSSA::KMeans::WcorrDistance" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-c7447213501cff814863b20e8251122a6bf98ea8.png)
Collaboration diagram for MSSA::KMeans::WcorrDistance:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="MSSA::KMeans::KMeansDistance" tooltip="MSSA::KMeans::KMeansDistance"]
"1" [label="MSSA::KMeans::WcorrDistance" tooltip="MSSA::KMeans::WcorrDistance" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-c7447213501cff814863b20e8251122a6bf98ea8.png)
-
class WcorrDistMulti : public MSSA::KMeans::KMeansDistance
- #include <KMeans.H>
Inheritence diagram for MSSA::KMeans::WcorrDistMulti:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="MSSA::KMeans::KMeansDistance" tooltip="MSSA::KMeans::KMeansDistance"]
"1" [label="MSSA::KMeans::WcorrDistMulti" tooltip="MSSA::KMeans::WcorrDistMulti" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-e6caac65642bdc20502c50dd2f011d8a41209e7c.png)
Collaboration diagram for MSSA::KMeans::WcorrDistMulti:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"2" [label="MSSA::KMeans::KMeansDistance" tooltip="MSSA::KMeans::KMeansDistance"]
"1" [label="MSSA::KMeans::WcorrDistMulti" tooltip="MSSA::KMeans::WcorrDistMulti" fillcolor="#BFBFBF"]
"1" -> "2" [dir=forward tooltip="public-inheritance"]
}](_images/graphviz-e6caac65642bdc20502c50dd2f011d8a41209e7c.png)
Public Functions
-
virtual double operator()(const std::vector<double> &x, const std::vector<double> &y)
Compute distance.
-
inline WcorrDistMulti(int numT, int numW, int nchn)
Constructor
- Parameters:
numT – is the size of the time series
numW – is the window length
nchn – is the number of appended channels
-
virtual double operator()(const std::vector<double> &x, const std::vector<double> &y)
-
class WRgrid
- #include <massmodel.H>
-
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"]
}](_images/graphviz-810056e31eb099d22bbbe821c26ae6ca18078056.png)
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"]
}](_images/graphviz-810056e31eb099d22bbbe821c26ae6ca18078056.png)
Configuration error.
-
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"]
}](_images/graphviz-72c91f6a7b3603ca4dc03a73638f1f8338de2329.png)
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"]
}](_images/graphviz-72c91f6a7b3603ca4dc03a73638f1f8338de2329.png)
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.
-
inline virtual double dens(double R)
-
template<class T>
class ZBrent - #include <ZBrent.H>
Public Functions
-
ZBrentReturn find(func_T func, T ¶m, double x1, double x2, double tol, double &result)
-
inline ZBrent()
-
ZBrentReturn find(func_T func, T ¶m, double x1, double x2, double tol, double &result)
-
namespace AltMath
-
namespace BasisClasses
Typedefs
-
using AccelFunctor = std::function<Eigen::MatrixXd&(double, Eigen::MatrixXd&, Eigen::MatrixXd&, BasisCoef)>
The function signature.
-
using BasisCoef = std::tuple<std::shared_ptr<Basis>, std::shared_ptr<CoefClasses::Coefs>>
Time-dependent potential-density model.
-
using BiorthBasisPtr = std::shared_ptr<BiorthBasis>
-
using Callback = std::function<bool(double, std::vector<double>&, std::vector<double>&, uint64_t)>
Callback function signature for selection particles to accumulate
-
using FieldBasisPtr = std::shared_ptr<FieldBasis>
-
typedef std::shared_ptr<VelocityBasis> VelocityBasisPtr
-
using AccelFunctor = std::function<Eigen::MatrixXd&(double, Eigen::MatrixXd&, Eigen::MatrixXd&, BasisCoef)>
-
namespace CoefClasses
Typedefs
-
using CoefStrPtr = std::shared_ptr<CoefStruct>
-
using CubeStrPtr = std::shared_ptr<CubeStruct>
-
using PlrFldPtr = std::shared_ptr<CylFldStruct>
-
using SlabStrPtr = std::shared_ptr<SlabStruct>
-
using SphFldPtr = std::shared_ptr<SphFldStruct>
-
using TrajStrPtr = std::shared_ptr<TrajStruct>
-
using CoefStrPtr = std::shared_ptr<CoefStruct>
-
namespace cxxopts
Typedefs
-
using OptionMap = std::unordered_map<std::string, std::shared_ptr<OptionDetails>>
-
using ParsedHashMap = std::unordered_map<size_t, OptionValue>
-
using PositionalListIterator = PositionalList::const_iterator
Functions
-
using OptionMap = std::unordered_map<std::string, std::shared_ptr<OptionDetails>>
-
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 R, typename T>
-
namespace detail
-
namespace parser_tool
Functions
-
inline IntegerDesc SplitInteger(const std::string &text)
-
inline IntegerDesc SplitInteger(const std::string &text)
-
namespace parser_tool
-
namespace Eigen
-
namespace Field
-
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.
-
template<typename coordinate_type, size_t dimensions>
-
namespace MSSA
Typedefs
Enums
Variables
-
const std::map<int, std::string> getTrendType = {{static_cast<std::underlying_type<TrendType>::type>(TrendType::perChannel), "per channel"}, {static_cast<std::underlying_type<TrendType>::type>(TrendType::totVar), "total variance"}, {static_cast<std::underlying_type<TrendType>::type>(TrendType::totPow), "total power"}}
Get enum names from a constant map (this is tedious; there is probably an easier way)
-
const std::map<int, std::string> getTrendType = {{static_cast<std::underlying_type<TrendType>::type>(TrendType::perChannel), "per channel"}, {static_cast<std::underlying_type<TrendType>::type>(TrendType::totVar), "total variance"}, {static_cast<std::underlying_type<TrendType>::type>(TrendType::totPow), "total power"}}
-
namespace KMeans
-
namespace ODE
-
namespace PR
Typedefs
-
typedef std::shared_ptr<ParticleReader> PRptr
-
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 RedSVD
Functions
-
template<typename MatrixType>
inline void gram_schmidt(MatrixType &mat)
-
template<typename MatrixType>
inline void sample_gaussian(MatrixType &mat)
-
template<typename MatrixType>
-
namespace std
-
namespace Utility
Typedefs
- file BasisFactory.H
- #include <functional>#include <Eigen/Eigen>#include <unsupported/Eigen/CXX11/Tensor>#include <yaml-cpp/yaml.h>#include <ParticleReader.H>#include <OrthoFunction.H>#include <Coefficients.H>#include <PseudoAccel.H>#include <YamlCheck.H>#include <localmpi.H>#include <exputils.H>#include <interp.H>
Include dependency graph for BasisFactory.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/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H" fillcolor="#BFBFBF"]
"33" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"30" [label="Coefficients.H" tooltip="Coefficients.H"]
"42" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
"27" [label="OrthoFunction.H" tooltip="OrthoFunction.H"]
"24" [label="Particle.H" tooltip="Particle.H"]
"6" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"34" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"37" [label="QuadLS.H" tooltip="QuadLS.H"]
"20" [label="StringTok.H" tooltip="StringTok.H"]
"38" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"40" [label="exputils.H" tooltip="exputils.H"]
"25" [label="gadget.H" tooltip="gadget.H"]
"28" [label="gaussQ.H" tooltip="gaussQ.H"]
"21" [label="header.H" tooltip="header.H"]
"41" [label="interp.H" tooltip="interp.H"]
"23" [label="localmpi.H" tooltip="localmpi.H"]
"26" [label="tipsy.H" tooltip="tipsy.H"]
"3" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"9" [label="algorithm" tooltip="algorithm"]
"36" [label="array" tooltip="array"]
"16" [label="cmath" tooltip="cmath"]
"19" [label="config_exp.h" tooltip="config_exp.h"]
"29" [label="cstdlib" tooltip="cstdlib"]
"35" [label="deque" tooltip="deque"]
"11" [label="fstream" tooltip="fstream"]
"2" [label="functional" tooltip="functional"]
"32" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"12" [label="iomanip" tooltip="iomanip"]
"10" [label="iostream" tooltip="iostream"]
"17" [label="list" tooltip="list"]
"43" [label="map" tooltip="map"]
"14" [label="memory" tooltip="memory"]
"18" [label="mpi.h" tooltip="mpi.h"]
"39" [label="set" tooltip="set"]
"22" [label="sstream" tooltip="sstream"]
"8" [label="stdexcept" tooltip="stdexcept"]
"15" [label="string" tooltip="string"]
"31" [label="tuple" tooltip="tuple"]
"7" [label="unordered_map" tooltip="unordered_map"]
"4" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"13" [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"]
"1" -> "6" [dir=forward tooltip="include"]
"1" -> "27" [dir=forward tooltip="include"]
"1" -> "30" [dir=forward tooltip="include"]
"1" -> "34" [dir=forward tooltip="include"]
"1" -> "38" [dir=forward tooltip="include"]
"1" -> "23" [dir=forward tooltip="include"]
"1" -> "40" [dir=forward tooltip="include"]
"1" -> "41" [dir=forward tooltip="include"]
"33" -> "14" [dir=forward tooltip="include"]
"33" -> "3" [dir=forward tooltip="include"]
"33" -> "4" [dir=forward tooltip="include"]
"30" -> "31" [dir=forward tooltip="include"]
"30" -> "8" [dir=forward tooltip="include"]
"30" -> "32" [dir=forward tooltip="include"]
"30" -> "3" [dir=forward tooltip="include"]
"30" -> "4" [dir=forward tooltip="include"]
"30" -> "5" [dir=forward tooltip="include"]
"30" -> "33" [dir=forward tooltip="include"]
"42" -> "13" [dir=forward tooltip="include"]
"42" -> "43" [dir=forward tooltip="include"]
"42" -> "15" [dir=forward tooltip="include"]
"27" -> "2" [dir=forward tooltip="include"]
"27" -> "14" [dir=forward tooltip="include"]
"27" -> "3" [dir=forward tooltip="include"]
"27" -> "28" [dir=forward tooltip="include"]
"24" -> "7" [dir=forward tooltip="include"]
"24" -> "13" [dir=forward tooltip="include"]
"24" -> "14" [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" -> "14" [dir=forward tooltip="include"]
"6" -> "15" [dir=forward tooltip="include"]
"6" -> "16" [dir=forward tooltip="include"]
"6" -> "17" [dir=forward tooltip="include"]
"6" -> "18" [dir=forward tooltip="include"]
"6" -> "19" [dir=forward tooltip="include"]
"6" -> "20" [dir=forward tooltip="include"]
"6" -> "21" [dir=forward tooltip="include"]
"6" -> "24" [dir=forward tooltip="include"]
"6" -> "25" [dir=forward tooltip="include"]
"6" -> "26" [dir=forward tooltip="include"]
"34" -> "35" [dir=forward tooltip="include"]
"34" -> "36" [dir=forward tooltip="include"]
"34" -> "3" [dir=forward tooltip="include"]
"34" -> "37" [dir=forward tooltip="include"]
"37" -> "10" [dir=forward tooltip="include"]
"37" -> "12" [dir=forward tooltip="include"]
"37" -> "31" [dir=forward tooltip="include"]
"38" -> "15" [dir=forward tooltip="include"]
"38" -> "39" [dir=forward tooltip="include"]
"38" -> "5" [dir=forward tooltip="include"]
"40" -> "15" [dir=forward tooltip="include"]
"40" -> "3" [dir=forward tooltip="include"]
"28" -> "10" [dir=forward tooltip="include"]
"28" -> "12" [dir=forward tooltip="include"]
"28" -> "22" [dir=forward tooltip="include"]
"28" -> "29" [dir=forward tooltip="include"]
"28" -> "15" [dir=forward tooltip="include"]
"28" -> "13" [dir=forward tooltip="include"]
"21" -> "10" [dir=forward tooltip="include"]
"21" -> "12" [dir=forward tooltip="include"]
"21" -> "22" [dir=forward tooltip="include"]
"21" -> "14" [dir=forward tooltip="include"]
"21" -> "23" [dir=forward tooltip="include"]
"41" -> "3" [dir=forward tooltip="include"]
"41" -> "13" [dir=forward tooltip="include"]
"41" -> "35" [dir=forward tooltip="include"]
"41" -> "42" [dir=forward tooltip="include"]
"23" -> "18" [dir=forward tooltip="include"]
"23" -> "10" [dir=forward tooltip="include"]
"23" -> "11" [dir=forward tooltip="include"]
"23" -> "12" [dir=forward tooltip="include"]
"23" -> "15" [dir=forward tooltip="include"]
}](_images/graphviz-2612aef1168ea526937d4b692ef475ff21c18e94.png)
This graph shows which files directly or indirectly include BasisFactory.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/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H" fillcolor="#BFBFBF"]
"2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"4" [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" -> "2" [dir=back tooltip="include"]
"1" -> "3" [dir=back tooltip="include"]
"1" -> "5" [dir=back tooltip="include"]
"1" -> "6" [dir=back tooltip="include"]
"3" -> "4" [dir=back tooltip="include"]
}](_images/graphviz-542ae337fd9d59d3667d7c4b0207461a0fefc929.png)
- file BiorthBasis.H
- #include <functional>#include <tuple>#include <Eigen/Eigen>#include <unsupported/Eigen/CXX11/Tensor>#include <yaml-cpp/yaml.h>#include <DiskDensityFunc.H>#include <ParticleReader.H>#include <Coefficients.H>#include <BiorthBess.H>#include <BasisFactory.H>#include <BiorthCube.H>#include <sltableMP2.H>#include <SLGridMP2.H>#include <YamlCheck.H>#include <BiorthCyl.H>#include <EmpCylSL.H>#include <localmpi.H>#include <exputils.H>
Include dependency graph for BiorthBasis.H:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"36" [label="BasisFactory.H" tooltip="BasisFactory.H"]
"1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" fillcolor="#BFBFBF"]
"34" [label="BiorthBess.H" tooltip="BiorthBess.H"]
"33" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"31" [label="Coefficients.H" tooltip="Coefficients.H"]
"50" [label="BiorthCube.H" tooltip="BiorthCube.H"]
"68" [label="BiorthCyl.H" tooltip="BiorthCyl.H"]
"7" [label="DiskDensityFunc.H" tooltip="DiskDensityFunc.H"]
"55" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
"61" [label="EXPmath.H" tooltip="EXPmath.H"]
"59" [label="EmpCyl2d.H" tooltip="EmpCyl2d.H"]
"69" [label="EmpCylSL.H" tooltip="EmpCylSL.H"]
"48" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
"37" [label="OrthoFunction.H" tooltip="OrthoFunction.H"]
"28" [label="Particle.H" tooltip="Particle.H"]
"10" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"40" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"54" [label="QPDistF.H" tooltip="QPDistF.H"]
"43" [label="QuadLS.H" tooltip="QuadLS.H"]
"65" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
"24" [label="StringTok.H" tooltip="StringTok.H"]
"71" [label="Timer.H" tooltip="Timer.H"]
"44" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"73" [label="coef.H" tooltip="coef.H"]
"46" [label="exputils.H" tooltip="exputils.H"]
"29" [label="gadget.H" tooltip="gadget.H"]
"38" [label="gaussQ.H" tooltip="gaussQ.H"]
"25" [label="header.H" tooltip="header.H"]
"47" [label="interp.H" tooltip="interp.H"]
"67" [label="libvars.H" tooltip="libvars.H"]
"27" [label="localmpi.H" tooltip="localmpi.H"]
"51" [label="massmodel.H" tooltip="massmodel.H"]
"53" [label="orbit.H" tooltip="orbit.H"]
"64" [label="sltableMP2.H" tooltip="sltableMP2.H"]
"30" [label="tipsy.H" tooltip="tipsy.H"]
"4" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"60" [label="Eigen/Eigenvalues" tooltip="Eigen/Eigenvalues"]
"13" [label="algorithm" tooltip="algorithm"]
"42" [label="array" tooltip="array"]
"35" [label="cassert" tooltip="cassert"]
"72" [label="chrono" tooltip="chrono"]
"20" [label="cmath" tooltip="cmath"]
"23" [label="config_exp.h" tooltip="config_exp.h"]
"39" [label="cstdlib" tooltip="cstdlib"]
"41" [label="deque" tooltip="deque"]
"15" [label="fstream" tooltip="fstream"]
"2" [label="functional" tooltip="functional"]
"58" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"56" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"57" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"32" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"63" [label="highfive/eigen.hpp" tooltip="highfive/eigen.hpp"]
"62" [label="highfive/highfive.hpp" tooltip="highfive/highfive.hpp"]
"16" [label="iomanip" tooltip="iomanip"]
"14" [label="iostream" tooltip="iostream"]
"70" [label="limits" tooltip="limits"]
"21" [label="list" tooltip="list"]
"49" [label="map" tooltip="map"]
"66" [label="math.h" tooltip="math.h"]
"18" [label="memory" tooltip="memory"]
"22" [label="mpi.h" tooltip="mpi.h"]
"9" [label="pybind11/embed.h" tooltip="pybind11/embed.h"]
"8" [label="pybind11/pybind11.h" tooltip="pybind11/pybind11.h"]
"52" [label="random" tooltip="random"]
"45" [label="set" tooltip="set"]
"26" [label="sstream" tooltip="sstream"]
"12" [label="stdexcept" tooltip="stdexcept"]
"19" [label="string" tooltip="string"]
"3" [label="tuple" tooltip="tuple"]
"11" [label="unordered_map" tooltip="unordered_map"]
"5" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"17" [label="vector" tooltip="vector"]
"6" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"36" -> "2" [dir=forward tooltip="include"]
"36" -> "4" [dir=forward tooltip="include"]
"36" -> "5" [dir=forward tooltip="include"]
"36" -> "6" [dir=forward tooltip="include"]
"36" -> "10" [dir=forward tooltip="include"]
"36" -> "37" [dir=forward tooltip="include"]
"36" -> "31" [dir=forward tooltip="include"]
"36" -> "40" [dir=forward tooltip="include"]
"36" -> "44" [dir=forward tooltip="include"]
"36" -> "27" [dir=forward tooltip="include"]
"36" -> "46" [dir=forward tooltip="include"]
"36" -> "47" [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" -> "10" [dir=forward tooltip="include"]
"1" -> "31" [dir=forward tooltip="include"]
"1" -> "34" [dir=forward tooltip="include"]
"1" -> "36" [dir=forward tooltip="include"]
"1" -> "50" [dir=forward tooltip="include"]
"1" -> "64" [dir=forward tooltip="include"]
"1" -> "65" [dir=forward tooltip="include"]
"1" -> "44" [dir=forward tooltip="include"]
"1" -> "68" [dir=forward tooltip="include"]
"1" -> "69" [dir=forward tooltip="include"]
"1" -> "27" [dir=forward tooltip="include"]
"1" -> "46" [dir=forward tooltip="include"]
"34" -> "35" [dir=forward tooltip="include"]
"34" -> "17" [dir=forward tooltip="include"]
"34" -> "18" [dir=forward tooltip="include"]
"34" -> "20" [dir=forward tooltip="include"]
"34" -> "4" [dir=forward tooltip="include"]
"33" -> "18" [dir=forward tooltip="include"]
"33" -> "4" [dir=forward tooltip="include"]
"33" -> "5" [dir=forward tooltip="include"]
"31" -> "3" [dir=forward tooltip="include"]
"31" -> "12" [dir=forward tooltip="include"]
"31" -> "32" [dir=forward tooltip="include"]
"31" -> "4" [dir=forward tooltip="include"]
"31" -> "5" [dir=forward tooltip="include"]
"31" -> "6" [dir=forward tooltip="include"]
"31" -> "33" [dir=forward tooltip="include"]
"50" -> "14" [dir=forward tooltip="include"]
"50" -> "15" [dir=forward tooltip="include"]
"50" -> "19" [dir=forward tooltip="include"]
"50" -> "20" [dir=forward tooltip="include"]
"50" -> "4" [dir=forward tooltip="include"]
"50" -> "22" [dir=forward tooltip="include"]
"50" -> "27" [dir=forward tooltip="include"]
"50" -> "23" [dir=forward tooltip="include"]
"50" -> "51" [dir=forward tooltip="include"]
"50" -> "6" [dir=forward tooltip="include"]
"50" -> "32" [dir=forward tooltip="include"]
"50" -> "56" [dir=forward tooltip="include"]
"50" -> "57" [dir=forward tooltip="include"]
"50" -> "58" [dir=forward tooltip="include"]
"50" -> "59" [dir=forward tooltip="include"]
"68" -> "14" [dir=forward tooltip="include"]
"68" -> "15" [dir=forward tooltip="include"]
"68" -> "19" [dir=forward tooltip="include"]
"68" -> "20" [dir=forward tooltip="include"]
"68" -> "4" [dir=forward tooltip="include"]
"68" -> "22" [dir=forward tooltip="include"]
"68" -> "27" [dir=forward tooltip="include"]
"68" -> "23" [dir=forward tooltip="include"]
"68" -> "51" [dir=forward tooltip="include"]
"68" -> "6" [dir=forward tooltip="include"]
"68" -> "32" [dir=forward tooltip="include"]
"68" -> "56" [dir=forward tooltip="include"]
"68" -> "57" [dir=forward tooltip="include"]
"68" -> "58" [dir=forward tooltip="include"]
"68" -> "59" [dir=forward tooltip="include"]
"7" -> "2" [dir=forward tooltip="include"]
"7" -> "8" [dir=forward tooltip="include"]
"7" -> "9" [dir=forward tooltip="include"]
"55" -> "51" [dir=forward tooltip="include"]
"59" -> "13" [dir=forward tooltip="include"]
"59" -> "18" [dir=forward tooltip="include"]
"59" -> "19" [dir=forward tooltip="include"]
"59" -> "17" [dir=forward tooltip="include"]
"59" -> "42" [dir=forward tooltip="include"]
"59" -> "3" [dir=forward tooltip="include"]
"59" -> "4" [dir=forward tooltip="include"]
"59" -> "60" [dir=forward tooltip="include"]
"59" -> "6" [dir=forward tooltip="include"]
"59" -> "23" [dir=forward tooltip="include"]
"59" -> "38" [dir=forward tooltip="include"]
"59" -> "61" [dir=forward tooltip="include"]
"59" -> "27" [dir=forward tooltip="include"]
"59" -> "62" [dir=forward tooltip="include"]
"59" -> "63" [dir=forward tooltip="include"]
"69" -> "2" [dir=forward tooltip="include"]
"69" -> "17" [dir=forward tooltip="include"]
"69" -> "18" [dir=forward tooltip="include"]
"69" -> "70" [dir=forward tooltip="include"]
"69" -> "20" [dir=forward tooltip="include"]
"69" -> "4" [dir=forward tooltip="include"]
"69" -> "38" [dir=forward tooltip="include"]
"69" -> "47" [dir=forward tooltip="include"]
"69" -> "71" [dir=forward tooltip="include"]
"69" -> "28" [dir=forward tooltip="include"]
"69" -> "65" [dir=forward tooltip="include"]
"69" -> "73" [dir=forward tooltip="include"]
"69" -> "67" [dir=forward tooltip="include"]
"48" -> "17" [dir=forward tooltip="include"]
"48" -> "49" [dir=forward tooltip="include"]
"48" -> "19" [dir=forward tooltip="include"]
"37" -> "2" [dir=forward tooltip="include"]
"37" -> "18" [dir=forward tooltip="include"]
"37" -> "4" [dir=forward tooltip="include"]
"37" -> "38" [dir=forward tooltip="include"]
"28" -> "11" [dir=forward tooltip="include"]
"28" -> "17" [dir=forward tooltip="include"]
"28" -> "18" [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" -> "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" -> "22" [dir=forward tooltip="include"]
"10" -> "23" [dir=forward tooltip="include"]
"10" -> "24" [dir=forward tooltip="include"]
"10" -> "25" [dir=forward tooltip="include"]
"10" -> "28" [dir=forward tooltip="include"]
"10" -> "29" [dir=forward tooltip="include"]
"10" -> "30" [dir=forward tooltip="include"]
"40" -> "41" [dir=forward tooltip="include"]
"40" -> "42" [dir=forward tooltip="include"]
"40" -> "4" [dir=forward tooltip="include"]
"40" -> "43" [dir=forward tooltip="include"]
"54" -> "16" [dir=forward tooltip="include"]
"54" -> "19" [dir=forward tooltip="include"]
"54" -> "49" [dir=forward tooltip="include"]
"54" -> "51" [dir=forward tooltip="include"]
"54" -> "55" [dir=forward tooltip="include"]
"54" -> "53" [dir=forward tooltip="include"]
"43" -> "14" [dir=forward tooltip="include"]
"43" -> "16" [dir=forward tooltip="include"]
"43" -> "3" [dir=forward tooltip="include"]
"65" -> "66" [dir=forward tooltip="include"]
"65" -> "14" [dir=forward tooltip="include"]
"65" -> "15" [dir=forward tooltip="include"]
"65" -> "19" [dir=forward tooltip="include"]
"65" -> "22" [dir=forward tooltip="include"]
"65" -> "27" [dir=forward tooltip="include"]
"65" -> "23" [dir=forward tooltip="include"]
"65" -> "51" [dir=forward tooltip="include"]
"65" -> "64" [dir=forward tooltip="include"]
"65" -> "6" [dir=forward tooltip="include"]
"65" -> "67" [dir=forward tooltip="include"]
"71" -> "14" [dir=forward tooltip="include"]
"71" -> "39" [dir=forward tooltip="include"]
"71" -> "72" [dir=forward tooltip="include"]
"44" -> "19" [dir=forward tooltip="include"]
"44" -> "45" [dir=forward tooltip="include"]
"44" -> "6" [dir=forward tooltip="include"]
"46" -> "19" [dir=forward tooltip="include"]
"46" -> "4" [dir=forward tooltip="include"]
"38" -> "14" [dir=forward tooltip="include"]
"38" -> "16" [dir=forward tooltip="include"]
"38" -> "26" [dir=forward tooltip="include"]
"38" -> "39" [dir=forward tooltip="include"]
"38" -> "19" [dir=forward tooltip="include"]
"38" -> "17" [dir=forward tooltip="include"]
"25" -> "14" [dir=forward tooltip="include"]
"25" -> "16" [dir=forward tooltip="include"]
"25" -> "26" [dir=forward tooltip="include"]
"25" -> "18" [dir=forward tooltip="include"]
"25" -> "27" [dir=forward tooltip="include"]
"47" -> "4" [dir=forward tooltip="include"]
"47" -> "17" [dir=forward tooltip="include"]
"47" -> "41" [dir=forward tooltip="include"]
"47" -> "48" [dir=forward tooltip="include"]
"67" -> "52" [dir=forward tooltip="include"]
"67" -> "22" [dir=forward tooltip="include"]
"27" -> "22" [dir=forward tooltip="include"]
"27" -> "14" [dir=forward tooltip="include"]
"27" -> "15" [dir=forward tooltip="include"]
"27" -> "16" [dir=forward tooltip="include"]
"27" -> "19" [dir=forward tooltip="include"]
"51" -> "17" [dir=forward tooltip="include"]
"51" -> "18" [dir=forward tooltip="include"]
"51" -> "52" [dir=forward tooltip="include"]
"51" -> "3" [dir=forward tooltip="include"]
"51" -> "4" [dir=forward tooltip="include"]
"51" -> "47" [dir=forward tooltip="include"]
"51" -> "53" [dir=forward tooltip="include"]
"51" -> "54" [dir=forward tooltip="include"]
"53" -> "2" [dir=forward tooltip="include"]
"53" -> "18" [dir=forward tooltip="include"]
"53" -> "4" [dir=forward tooltip="include"]
"53" -> "38" [dir=forward tooltip="include"]
"64" -> "4" [dir=forward tooltip="include"]
}](_images/graphviz-b93c2f2be8ed65d128a8735cd3712bb2bff8e6f9.png)
- file BiorthBess.H
- #include <cassert>#include <vector>#include <memory>#include <cmath>#include <Eigen/Eigen>
Include dependency graph for BiorthBess.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/expui/BiorthBess.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBess.H" fillcolor="#BFBFBF"]
"6" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"2" [label="cassert" tooltip="cassert"]
"5" [label="cmath" tooltip="cmath"]
"4" [label="memory" tooltip="memory"]
"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"]
}](_images/graphviz-ed1a5e6ff885504626e08d0106a72f7539494cc4.png)
This graph shows which files directly or indirectly include BiorthBess.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/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBess.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBess.H" fillcolor="#BFBFBF"]
"1" -> "2" [dir=back tooltip="include"]
}](_images/graphviz-5776b24e59d3ee37c4ff8900ef44647ecf0610aa.png)
- file Centering.H
- #include <ParticleReader.H>
Include dependency graph for Centering.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/expui/Centering.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Centering.H" fillcolor="#BFBFBF"]
"20" [label="Particle.H" tooltip="Particle.H"]
"2" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"16" [label="StringTok.H" tooltip="StringTok.H"]
"21" [label="gadget.H" tooltip="gadget.H"]
"17" [label="header.H" tooltip="header.H"]
"19" [label="localmpi.H" tooltip="localmpi.H"]
"22" [label="tipsy.H" tooltip="tipsy.H"]
"5" [label="algorithm" tooltip="algorithm"]
"12" [label="cmath" tooltip="cmath"]
"15" [label="config_exp.h" tooltip="config_exp.h"]
"7" [label="fstream" tooltip="fstream"]
"8" [label="iomanip" tooltip="iomanip"]
"6" [label="iostream" tooltip="iostream"]
"13" [label="list" tooltip="list"]
"10" [label="memory" tooltip="memory"]
"14" [label="mpi.h" tooltip="mpi.h"]
"18" [label="sstream" tooltip="sstream"]
"4" [label="stdexcept" tooltip="stdexcept"]
"11" [label="string" tooltip="string"]
"3" [label="unordered_map" tooltip="unordered_map"]
"9" [label="vector" tooltip="vector"]
"1" -> "2" [dir=forward tooltip="include"]
"20" -> "3" [dir=forward tooltip="include"]
"20" -> "9" [dir=forward tooltip="include"]
"20" -> "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" -> "13" [dir=forward tooltip="include"]
"2" -> "14" [dir=forward tooltip="include"]
"2" -> "15" [dir=forward tooltip="include"]
"2" -> "16" [dir=forward tooltip="include"]
"2" -> "17" [dir=forward tooltip="include"]
"2" -> "20" [dir=forward tooltip="include"]
"2" -> "21" [dir=forward tooltip="include"]
"2" -> "22" [dir=forward tooltip="include"]
"17" -> "6" [dir=forward tooltip="include"]
"17" -> "8" [dir=forward tooltip="include"]
"17" -> "18" [dir=forward tooltip="include"]
"17" -> "10" [dir=forward tooltip="include"]
"17" -> "19" [dir=forward tooltip="include"]
"19" -> "14" [dir=forward tooltip="include"]
"19" -> "6" [dir=forward tooltip="include"]
"19" -> "7" [dir=forward tooltip="include"]
"19" -> "8" [dir=forward tooltip="include"]
"19" -> "11" [dir=forward tooltip="include"]
}](_images/graphviz-0ec325fa3dab141de7d8268af69eb43337927f3a.png)
- file CoefContainer.H
- #include <memory>#include <tuple>#include <map>#include <set>#include <Eigen/Dense>#include <Coefficients.H>
Include dependency graph for CoefContainer.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/expui/CoefContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/CoefContainer.H" fillcolor="#BFBFBF"]
"13" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"7" [label="Coefficients.H" tooltip="Coefficients.H"]
"6" [label="Eigen/Dense" tooltip="Eigen/Dense"]
"10" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"9" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"4" [label="map" tooltip="map"]
"2" [label="memory" tooltip="memory"]
"5" [label="set" tooltip="set"]
"8" [label="stdexcept" tooltip="stdexcept"]
"3" [label="tuple" tooltip="tuple"]
"11" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"12" [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"]
"13" -> "2" [dir=forward tooltip="include"]
"13" -> "10" [dir=forward tooltip="include"]
"13" -> "11" [dir=forward tooltip="include"]
"7" -> "3" [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"]
"7" -> "13" [dir=forward tooltip="include"]
}](_images/graphviz-9635bdd5467ecd5c0f669d86eb7c8761db7cf563.png)
This graph shows which files directly or indirectly include CoefContainer.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/expui/CoefContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/CoefContainer.H" fillcolor="#BFBFBF"]
"2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Koopman.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Koopman.H"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/expMSSA.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/expMSSA.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"]
"9" [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/Cylinder.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cylinder.H"]
"6" [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/FlatDisk.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/FlatDisk.H"]
"7" [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"]
"8" [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"]
"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"]
"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"]
"5" [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"]
"1" -> "3" [dir=back tooltip="include"]
"1" -> "4" [dir=back tooltip="include"]
"1" -> "8" [dir=back tooltip="include"]
"1" -> "11" [dir=back tooltip="include"]
"12" -> "5" [dir=back tooltip="include"]
"4" -> "5" [dir=back tooltip="include"]
"8" -> "9" [dir=back tooltip="include"]
"8" -> "10" [dir=back tooltip="include"]
"13" -> "5" [dir=back tooltip="include"]
"11" -> "12" [dir=back tooltip="include"]
"11" -> "13" [dir=back tooltip="include"]
"5" -> "6" [dir=back tooltip="include"]
"5" -> "7" [dir=back tooltip="include"]
}](_images/graphviz-4f693aa04756b4a016fdcdc4c932580676a73b05.png)
- file Coefficients.H
- #include <tuple>#include <stdexcept>#include <highfive/H5File.hpp>#include <Eigen/Eigen>#include <unsupported/Eigen/CXX11/Tensor>#include <yaml-cpp/yaml.h>#include <CoefStruct.H>
Include dependency graph for Coefficients.H:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"8" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Coefficients.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Coefficients.H" fillcolor="#BFBFBF"]
"5" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"4" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"9" [label="memory" tooltip="memory"]
"3" [label="stdexcept" tooltip="stdexcept"]
"2" [label="tuple" tooltip="tuple"]
"6" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"7" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"8" -> "9" [dir=forward tooltip="include"]
"8" -> "5" [dir=forward tooltip="include"]
"8" -> "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"]
}](_images/graphviz-b91f0f6abec98194e990988097ef706d4e90dedb.png)
This graph shows which files directly or indirectly include Coefficients.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/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/CoefContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/CoefContainer.H"]
"1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Coefficients.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Coefficients.H" fillcolor="#BFBFBF"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Koopman.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Koopman.H"]
"7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/expMSSA.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/expMSSA.H"]
"19" [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"]
"16" [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/Cube.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/Cube.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"]
"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"]
"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"]
"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"]
"5" [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"]
"15" [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"]
"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"]
"20" [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"]
"18" [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"]
"2" -> "3" [dir=back tooltip="include"]
"2" -> "4" [dir=back tooltip="include"]
"2" -> "6" [dir=back tooltip="include"]
"2" -> "7" [dir=back tooltip="include"]
"8" -> "9" [dir=back tooltip="include"]
"8" -> "10" [dir=back tooltip="include"]
"8" -> "11" [dir=back tooltip="include"]
"8" -> "15" [dir=back tooltip="include"]
"8" -> "18" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"1" -> "3" [dir=back tooltip="include"]
"1" -> "8" [dir=back tooltip="include"]
"1" -> "4" [dir=back tooltip="include"]
"1" -> "6" [dir=back tooltip="include"]
"1" -> "7" [dir=back tooltip="include"]
"1" -> "21" [dir=back tooltip="include"]
"1" -> "11" [dir=back tooltip="include"]
"1" -> "5" [dir=back tooltip="include"]
"1" -> "15" [dir=back tooltip="include"]
"1" -> "22" [dir=back tooltip="include"]
"1" -> "18" [dir=back tooltip="include"]
"4" -> "5" [dir=back tooltip="include"]
"19" -> "12" [dir=back tooltip="include"]
"11" -> "12" [dir=back tooltip="include"]
"15" -> "16" [dir=back tooltip="include"]
"15" -> "17" [dir=back tooltip="include"]
"20" -> "12" [dir=back tooltip="include"]
"18" -> "19" [dir=back tooltip="include"]
"18" -> "20" [dir=back tooltip="include"]
"12" -> "13" [dir=back tooltip="include"]
"12" -> "14" [dir=back tooltip="include"]
}](_images/graphviz-3081c9bc3b38406f7414cdfefd57680dbd12c0d1.png)
- file CoefStruct.H
- #include <memory>#include <Eigen/Eigen>#include <unsupported/Eigen/CXX11/Tensor>
Include dependency graph for CoefStruct.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/expui/CoefStruct.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/CoefStruct.H" fillcolor="#BFBFBF"]
"3" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"2" [label="memory" tooltip="memory"]
"4" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"1" -> "2" [dir=forward tooltip="include"]
"1" -> "3" [dir=forward tooltip="include"]
"1" -> "4" [dir=forward tooltip="include"]
}](_images/graphviz-c54608c073a33fbb325649dc47050b756e47e130.png)
This graph shows which files directly or indirectly include CoefStruct.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/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/CoefContainer.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/CoefContainer.H"]
"1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/CoefStruct.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/CoefStruct.H" fillcolor="#BFBFBF"]
"2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Coefficients.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Coefficients.H"]
"5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Koopman.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Koopman.H"]
"8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"11" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/expMSSA.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/expMSSA.H"]
"20" [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"]
"17" [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"]
"22" [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"]
"12" [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"]
"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"]
"18" [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"]
"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"]
"6" [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"]
"16" [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"]
"23" [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"]
"21" [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/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"]
"3" -> "4" [dir=back tooltip="include"]
"3" -> "5" [dir=back tooltip="include"]
"3" -> "7" [dir=back tooltip="include"]
"3" -> "8" [dir=back tooltip="include"]
"9" -> "10" [dir=back tooltip="include"]
"9" -> "11" [dir=back tooltip="include"]
"9" -> "12" [dir=back tooltip="include"]
"9" -> "16" [dir=back tooltip="include"]
"9" -> "19" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"2" -> "3" [dir=back tooltip="include"]
"2" -> "4" [dir=back tooltip="include"]
"2" -> "9" [dir=back tooltip="include"]
"2" -> "5" [dir=back tooltip="include"]
"2" -> "7" [dir=back tooltip="include"]
"2" -> "8" [dir=back tooltip="include"]
"2" -> "22" [dir=back tooltip="include"]
"2" -> "12" [dir=back tooltip="include"]
"2" -> "6" [dir=back tooltip="include"]
"2" -> "16" [dir=back tooltip="include"]
"2" -> "23" [dir=back tooltip="include"]
"2" -> "19" [dir=back tooltip="include"]
"5" -> "6" [dir=back tooltip="include"]
"20" -> "13" [dir=back tooltip="include"]
"12" -> "13" [dir=back tooltip="include"]
"16" -> "17" [dir=back tooltip="include"]
"16" -> "18" [dir=back tooltip="include"]
"21" -> "13" [dir=back tooltip="include"]
"19" -> "20" [dir=back tooltip="include"]
"19" -> "21" [dir=back tooltip="include"]
"13" -> "14" [dir=back tooltip="include"]
"13" -> "15" [dir=back tooltip="include"]
}](_images/graphviz-a451d226989b34cad42239b4464a43a672e33346.png)
- file expMSSA.H
- #include <yaml-cpp/yaml.h>#include “CoefContainer.H”
Include dependency graph for expMSSA.H:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"3" [label="CoefContainer.H" tooltip="CoefContainer.H"]
"14" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"9" [label="Coefficients.H" tooltip="Coefficients.H"]
"1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/expMSSA.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/expMSSA.H" fillcolor="#BFBFBF"]
"8" [label="Eigen/Dense" tooltip="Eigen/Dense"]
"12" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"11" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"6" [label="map" tooltip="map"]
"4" [label="memory" tooltip="memory"]
"7" [label="set" tooltip="set"]
"10" [label="stdexcept" tooltip="stdexcept"]
"5" [label="tuple" tooltip="tuple"]
"13" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"2" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"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"]
"14" -> "4" [dir=forward tooltip="include"]
"14" -> "12" [dir=forward tooltip="include"]
"14" -> "13" [dir=forward tooltip="include"]
"9" -> "5" [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" -> "2" [dir=forward tooltip="include"]
"9" -> "14" [dir=forward tooltip="include"]
"1" -> "2" [dir=forward tooltip="include"]
"1" -> "3" [dir=forward tooltip="include"]
}](_images/graphviz-ecfc8df278c5c3619a2654c216abcf9a0d302355.png)
- file FieldBasis.H
- #include <functional>#include <Eigen/Eigen>#include <unsupported/Eigen/CXX11/Tensor>#include <yaml-cpp/yaml.h>#include <ParticleReader.H>#include <OrthoFunction.H>#include <Coefficients.H>#include <YamlCheck.H>#include <localmpi.H>#include <interp.H>#include <BasisFactory.H>
Include dependency graph for FieldBasis.H:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"40" [label="BasisFactory.H" tooltip="BasisFactory.H"]
"33" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"30" [label="Coefficients.H" tooltip="Coefficients.H"]
"1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" fillcolor="#BFBFBF"]
"38" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
"27" [label="OrthoFunction.H" tooltip="OrthoFunction.H"]
"24" [label="Particle.H" tooltip="Particle.H"]
"6" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"41" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"43" [label="QuadLS.H" tooltip="QuadLS.H"]
"20" [label="StringTok.H" tooltip="StringTok.H"]
"34" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"44" [label="exputils.H" tooltip="exputils.H"]
"25" [label="gadget.H" tooltip="gadget.H"]
"28" [label="gaussQ.H" tooltip="gaussQ.H"]
"21" [label="header.H" tooltip="header.H"]
"36" [label="interp.H" tooltip="interp.H"]
"23" [label="localmpi.H" tooltip="localmpi.H"]
"26" [label="tipsy.H" tooltip="tipsy.H"]
"3" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"9" [label="algorithm" tooltip="algorithm"]
"42" [label="array" tooltip="array"]
"16" [label="cmath" tooltip="cmath"]
"19" [label="config_exp.h" tooltip="config_exp.h"]
"29" [label="cstdlib" tooltip="cstdlib"]
"37" [label="deque" tooltip="deque"]
"11" [label="fstream" tooltip="fstream"]
"2" [label="functional" tooltip="functional"]
"32" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"12" [label="iomanip" tooltip="iomanip"]
"10" [label="iostream" tooltip="iostream"]
"17" [label="list" tooltip="list"]
"39" [label="map" tooltip="map"]
"14" [label="memory" tooltip="memory"]
"18" [label="mpi.h" tooltip="mpi.h"]
"35" [label="set" tooltip="set"]
"22" [label="sstream" tooltip="sstream"]
"8" [label="stdexcept" tooltip="stdexcept"]
"15" [label="string" tooltip="string"]
"31" [label="tuple" tooltip="tuple"]
"7" [label="unordered_map" tooltip="unordered_map"]
"4" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"13" [label="vector" tooltip="vector"]
"5" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"40" -> "2" [dir=forward tooltip="include"]
"40" -> "3" [dir=forward tooltip="include"]
"40" -> "4" [dir=forward tooltip="include"]
"40" -> "5" [dir=forward tooltip="include"]
"40" -> "6" [dir=forward tooltip="include"]
"40" -> "27" [dir=forward tooltip="include"]
"40" -> "30" [dir=forward tooltip="include"]
"40" -> "41" [dir=forward tooltip="include"]
"40" -> "34" [dir=forward tooltip="include"]
"40" -> "23" [dir=forward tooltip="include"]
"40" -> "44" [dir=forward tooltip="include"]
"40" -> "36" [dir=forward tooltip="include"]
"33" -> "14" [dir=forward tooltip="include"]
"33" -> "3" [dir=forward tooltip="include"]
"33" -> "4" [dir=forward tooltip="include"]
"30" -> "31" [dir=forward tooltip="include"]
"30" -> "8" [dir=forward tooltip="include"]
"30" -> "32" [dir=forward tooltip="include"]
"30" -> "3" [dir=forward tooltip="include"]
"30" -> "4" [dir=forward tooltip="include"]
"30" -> "5" [dir=forward tooltip="include"]
"30" -> "33" [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" -> "27" [dir=forward tooltip="include"]
"1" -> "30" [dir=forward tooltip="include"]
"1" -> "34" [dir=forward tooltip="include"]
"1" -> "23" [dir=forward tooltip="include"]
"1" -> "36" [dir=forward tooltip="include"]
"1" -> "40" [dir=forward tooltip="include"]
"38" -> "13" [dir=forward tooltip="include"]
"38" -> "39" [dir=forward tooltip="include"]
"38" -> "15" [dir=forward tooltip="include"]
"27" -> "2" [dir=forward tooltip="include"]
"27" -> "14" [dir=forward tooltip="include"]
"27" -> "3" [dir=forward tooltip="include"]
"27" -> "28" [dir=forward tooltip="include"]
"24" -> "7" [dir=forward tooltip="include"]
"24" -> "13" [dir=forward tooltip="include"]
"24" -> "14" [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" -> "14" [dir=forward tooltip="include"]
"6" -> "15" [dir=forward tooltip="include"]
"6" -> "16" [dir=forward tooltip="include"]
"6" -> "17" [dir=forward tooltip="include"]
"6" -> "18" [dir=forward tooltip="include"]
"6" -> "19" [dir=forward tooltip="include"]
"6" -> "20" [dir=forward tooltip="include"]
"6" -> "21" [dir=forward tooltip="include"]
"6" -> "24" [dir=forward tooltip="include"]
"6" -> "25" [dir=forward tooltip="include"]
"6" -> "26" [dir=forward tooltip="include"]
"41" -> "37" [dir=forward tooltip="include"]
"41" -> "42" [dir=forward tooltip="include"]
"41" -> "3" [dir=forward tooltip="include"]
"41" -> "43" [dir=forward tooltip="include"]
"43" -> "10" [dir=forward tooltip="include"]
"43" -> "12" [dir=forward tooltip="include"]
"43" -> "31" [dir=forward tooltip="include"]
"34" -> "15" [dir=forward tooltip="include"]
"34" -> "35" [dir=forward tooltip="include"]
"34" -> "5" [dir=forward tooltip="include"]
"44" -> "15" [dir=forward tooltip="include"]
"44" -> "3" [dir=forward tooltip="include"]
"28" -> "10" [dir=forward tooltip="include"]
"28" -> "12" [dir=forward tooltip="include"]
"28" -> "22" [dir=forward tooltip="include"]
"28" -> "29" [dir=forward tooltip="include"]
"28" -> "15" [dir=forward tooltip="include"]
"28" -> "13" [dir=forward tooltip="include"]
"21" -> "10" [dir=forward tooltip="include"]
"21" -> "12" [dir=forward tooltip="include"]
"21" -> "22" [dir=forward tooltip="include"]
"21" -> "14" [dir=forward tooltip="include"]
"21" -> "23" [dir=forward tooltip="include"]
"36" -> "3" [dir=forward tooltip="include"]
"36" -> "13" [dir=forward tooltip="include"]
"36" -> "37" [dir=forward tooltip="include"]
"36" -> "38" [dir=forward tooltip="include"]
"23" -> "18" [dir=forward tooltip="include"]
"23" -> "10" [dir=forward tooltip="include"]
"23" -> "11" [dir=forward tooltip="include"]
"23" -> "12" [dir=forward tooltip="include"]
"23" -> "15" [dir=forward tooltip="include"]
}](_images/graphviz-697d9cb91dfaa8f9f77bd85dd698fed414d8b545.png)
This graph shows which files directly or indirectly include FieldBasis.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/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" fillcolor="#BFBFBF"]
"2" [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" -> "2" [dir=back tooltip="include"]
}](_images/graphviz-7e7302a61137568cb48e519cbde9df1c975b7c43.png)
- file FieldGenerator.H
- #include <string_view>#include <vector>#include <map>#include <BasisFactory.H>#include <Coefficients.H>
Include dependency graph for FieldGenerator.H:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"5" [label="BasisFactory.H" tooltip="BasisFactory.H"]
"36" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"33" [label="Coefficients.H" tooltip="Coefficients.H"]
"1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" fillcolor="#BFBFBF"]
"45" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
"30" [label="OrthoFunction.H" tooltip="OrthoFunction.H"]
"27" [label="Particle.H" tooltip="Particle.H"]
"10" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"37" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"40" [label="QuadLS.H" tooltip="QuadLS.H"]
"23" [label="StringTok.H" tooltip="StringTok.H"]
"41" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"43" [label="exputils.H" tooltip="exputils.H"]
"28" [label="gadget.H" tooltip="gadget.H"]
"31" [label="gaussQ.H" tooltip="gaussQ.H"]
"24" [label="header.H" tooltip="header.H"]
"44" [label="interp.H" tooltip="interp.H"]
"26" [label="localmpi.H" tooltip="localmpi.H"]
"29" [label="tipsy.H" tooltip="tipsy.H"]
"7" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"13" [label="algorithm" tooltip="algorithm"]
"39" [label="array" tooltip="array"]
"19" [label="cmath" tooltip="cmath"]
"22" [label="config_exp.h" tooltip="config_exp.h"]
"32" [label="cstdlib" tooltip="cstdlib"]
"38" [label="deque" tooltip="deque"]
"15" [label="fstream" tooltip="fstream"]
"6" [label="functional" tooltip="functional"]
"35" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"16" [label="iomanip" tooltip="iomanip"]
"14" [label="iostream" tooltip="iostream"]
"20" [label="list" tooltip="list"]
"4" [label="map" tooltip="map"]
"17" [label="memory" tooltip="memory"]
"21" [label="mpi.h" tooltip="mpi.h"]
"42" [label="set" tooltip="set"]
"25" [label="sstream" tooltip="sstream"]
"12" [label="stdexcept" tooltip="stdexcept"]
"18" [label="string" tooltip="string"]
"2" [label="string_view" tooltip="string_view"]
"34" [label="tuple" tooltip="tuple"]
"11" [label="unordered_map" tooltip="unordered_map"]
"8" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"3" [label="vector" tooltip="vector"]
"9" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"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" -> "30" [dir=forward tooltip="include"]
"5" -> "33" [dir=forward tooltip="include"]
"5" -> "37" [dir=forward tooltip="include"]
"5" -> "41" [dir=forward tooltip="include"]
"5" -> "26" [dir=forward tooltip="include"]
"5" -> "43" [dir=forward tooltip="include"]
"5" -> "44" [dir=forward tooltip="include"]
"36" -> "17" [dir=forward tooltip="include"]
"36" -> "7" [dir=forward tooltip="include"]
"36" -> "8" [dir=forward tooltip="include"]
"33" -> "34" [dir=forward tooltip="include"]
"33" -> "12" [dir=forward tooltip="include"]
"33" -> "35" [dir=forward tooltip="include"]
"33" -> "7" [dir=forward tooltip="include"]
"33" -> "8" [dir=forward tooltip="include"]
"33" -> "9" [dir=forward tooltip="include"]
"33" -> "36" [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" -> "33" [dir=forward tooltip="include"]
"45" -> "3" [dir=forward tooltip="include"]
"45" -> "4" [dir=forward tooltip="include"]
"45" -> "18" [dir=forward tooltip="include"]
"30" -> "6" [dir=forward tooltip="include"]
"30" -> "17" [dir=forward tooltip="include"]
"30" -> "7" [dir=forward tooltip="include"]
"30" -> "31" [dir=forward tooltip="include"]
"27" -> "11" [dir=forward tooltip="include"]
"27" -> "3" [dir=forward tooltip="include"]
"27" -> "17" [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" -> "3" [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" -> "22" [dir=forward tooltip="include"]
"10" -> "23" [dir=forward tooltip="include"]
"10" -> "24" [dir=forward tooltip="include"]
"10" -> "27" [dir=forward tooltip="include"]
"10" -> "28" [dir=forward tooltip="include"]
"10" -> "29" [dir=forward tooltip="include"]
"37" -> "38" [dir=forward tooltip="include"]
"37" -> "39" [dir=forward tooltip="include"]
"37" -> "7" [dir=forward tooltip="include"]
"37" -> "40" [dir=forward tooltip="include"]
"40" -> "14" [dir=forward tooltip="include"]
"40" -> "16" [dir=forward tooltip="include"]
"40" -> "34" [dir=forward tooltip="include"]
"41" -> "18" [dir=forward tooltip="include"]
"41" -> "42" [dir=forward tooltip="include"]
"41" -> "9" [dir=forward tooltip="include"]
"43" -> "18" [dir=forward tooltip="include"]
"43" -> "7" [dir=forward tooltip="include"]
"31" -> "14" [dir=forward tooltip="include"]
"31" -> "16" [dir=forward tooltip="include"]
"31" -> "25" [dir=forward tooltip="include"]
"31" -> "32" [dir=forward tooltip="include"]
"31" -> "18" [dir=forward tooltip="include"]
"31" -> "3" [dir=forward tooltip="include"]
"24" -> "14" [dir=forward tooltip="include"]
"24" -> "16" [dir=forward tooltip="include"]
"24" -> "25" [dir=forward tooltip="include"]
"24" -> "17" [dir=forward tooltip="include"]
"24" -> "26" [dir=forward tooltip="include"]
"44" -> "7" [dir=forward tooltip="include"]
"44" -> "3" [dir=forward tooltip="include"]
"44" -> "38" [dir=forward tooltip="include"]
"44" -> "45" [dir=forward tooltip="include"]
"26" -> "21" [dir=forward tooltip="include"]
"26" -> "14" [dir=forward tooltip="include"]
"26" -> "15" [dir=forward tooltip="include"]
"26" -> "16" [dir=forward tooltip="include"]
"26" -> "18" [dir=forward tooltip="include"]
}](_images/graphviz-4c82c88927ab0157daad5dbe889f2cd2e2cb1316.png)
- file KMeans.H
- #include <algorithm>#include <iostream>#include <iomanip>#include <vector>#include <limits>#include <memory>#include <tuple>
Include dependency graph for KMeans.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/expui/KMeans.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/KMeans.H" fillcolor="#BFBFBF"]
"2" [label="algorithm" tooltip="algorithm"]
"4" [label="iomanip" tooltip="iomanip"]
"3" [label="iostream" tooltip="iostream"]
"6" [label="limits" tooltip="limits"]
"7" [label="memory" tooltip="memory"]
"8" [label="tuple" tooltip="tuple"]
"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"]
}](_images/graphviz-736cad712ba28cf0ac39c8be160dbe691f4ff894.png)
- file Koopman.H
- #include <yaml-cpp/yaml.h>#include “CoefContainer.H”
Include dependency graph for Koopman.H:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"3" [label="CoefContainer.H" tooltip="CoefContainer.H"]
"14" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"9" [label="Coefficients.H" tooltip="Coefficients.H"]
"1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Koopman.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Koopman.H" fillcolor="#BFBFBF"]
"8" [label="Eigen/Dense" tooltip="Eigen/Dense"]
"12" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"11" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"6" [label="map" tooltip="map"]
"4" [label="memory" tooltip="memory"]
"7" [label="set" tooltip="set"]
"10" [label="stdexcept" tooltip="stdexcept"]
"5" [label="tuple" tooltip="tuple"]
"13" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"2" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"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"]
"14" -> "4" [dir=forward tooltip="include"]
"14" -> "12" [dir=forward tooltip="include"]
"14" -> "13" [dir=forward tooltip="include"]
"9" -> "5" [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" -> "2" [dir=forward tooltip="include"]
"9" -> "14" [dir=forward tooltip="include"]
"1" -> "2" [dir=forward tooltip="include"]
"1" -> "3" [dir=forward tooltip="include"]
}](_images/graphviz-47622d006e07f51e90df6f87c7ae47c6c101a94b.png)
- file OrthoBasisFactory.H
- #include <functional>#include <Eigen/Eigen>#include <unsupported/Eigen/CXX11/Tensor>#include <yaml-cpp/yaml.h>#include <ParticleReader.H>#include <OrthoFunction.H>#include <Coefficients.H>#include <YamlCheck.H>#include <localmpi.H>#include <interp.H>#include <BasisFactory.H>
Include dependency graph for OrthoBasisFactory.H:
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"40" [label="BasisFactory.H" tooltip="BasisFactory.H"]
"33" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"30" [label="Coefficients.H" tooltip="Coefficients.H"]
"1" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" fillcolor="#BFBFBF"]
"38" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
"27" [label="OrthoFunction.H" tooltip="OrthoFunction.H"]
"24" [label="Particle.H" tooltip="Particle.H"]
"6" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"41" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"43" [label="QuadLS.H" tooltip="QuadLS.H"]
"20" [label="StringTok.H" tooltip="StringTok.H"]
"34" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"44" [label="exputils.H" tooltip="exputils.H"]
"25" [label="gadget.H" tooltip="gadget.H"]
"28" [label="gaussQ.H" tooltip="gaussQ.H"]
"21" [label="header.H" tooltip="header.H"]
"36" [label="interp.H" tooltip="interp.H"]
"23" [label="localmpi.H" tooltip="localmpi.H"]
"26" [label="tipsy.H" tooltip="tipsy.H"]
"3" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"9" [label="algorithm" tooltip="algorithm"]
"42" [label="array" tooltip="array"]
"16" [label="cmath" tooltip="cmath"]
"19" [label="config_exp.h" tooltip="config_exp.h"]
"29" [label="cstdlib" tooltip="cstdlib"]
"37" [label="deque" tooltip="deque"]
"11" [label="fstream" tooltip="fstream"]
"2" [label="functional" tooltip="functional"]
"32" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"12" [label="iomanip" tooltip="iomanip"]
"10" [label="iostream" tooltip="iostream"]
"17" [label="list" tooltip="list"]
"39" [label="map" tooltip="map"]
"14" [label="memory" tooltip="memory"]
"18" [label="mpi.h" tooltip="mpi.h"]
"35" [label="set" tooltip="set"]
"22" [label="sstream" tooltip="sstream"]
"8" [label="stdexcept" tooltip="stdexcept"]
"15" [label="string" tooltip="string"]
"31" [label="tuple" tooltip="tuple"]
"7" [label="unordered_map" tooltip="unordered_map"]
"4" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"13" [label="vector" tooltip="vector"]
"5" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"40" -> "2" [dir=forward tooltip="include"]
"40" -> "3" [dir=forward tooltip="include"]
"40" -> "4" [dir=forward tooltip="include"]
"40" -> "5" [dir=forward tooltip="include"]
"40" -> "6" [dir=forward tooltip="include"]
"40" -> "27" [dir=forward tooltip="include"]
"40" -> "30" [dir=forward tooltip="include"]
"40" -> "41" [dir=forward tooltip="include"]
"40" -> "34" [dir=forward tooltip="include"]
"40" -> "23" [dir=forward tooltip="include"]
"40" -> "44" [dir=forward tooltip="include"]
"40" -> "36" [dir=forward tooltip="include"]
"33" -> "14" [dir=forward tooltip="include"]
"33" -> "3" [dir=forward tooltip="include"]
"33" -> "4" [dir=forward tooltip="include"]
"30" -> "31" [dir=forward tooltip="include"]
"30" -> "8" [dir=forward tooltip="include"]
"30" -> "32" [dir=forward tooltip="include"]
"30" -> "3" [dir=forward tooltip="include"]
"30" -> "4" [dir=forward tooltip="include"]
"30" -> "5" [dir=forward tooltip="include"]
"30" -> "33" [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" -> "27" [dir=forward tooltip="include"]
"1" -> "30" [dir=forward tooltip="include"]
"1" -> "34" [dir=forward tooltip="include"]
"1" -> "23" [dir=forward tooltip="include"]
"1" -> "36" [dir=forward tooltip="include"]
"1" -> "40" [dir=forward tooltip="include"]
"38" -> "13" [dir=forward tooltip="include"]
"38" -> "39" [dir=forward tooltip="include"]
"38" -> "15" [dir=forward tooltip="include"]
"27" -> "2" [dir=forward tooltip="include"]
"27" -> "14" [dir=forward tooltip="include"]
"27" -> "3" [dir=forward tooltip="include"]
"27" -> "28" [dir=forward tooltip="include"]
"24" -> "7" [dir=forward tooltip="include"]
"24" -> "13" [dir=forward tooltip="include"]
"24" -> "14" [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" -> "14" [dir=forward tooltip="include"]
"6" -> "15" [dir=forward tooltip="include"]
"6" -> "16" [dir=forward tooltip="include"]
"6" -> "17" [dir=forward tooltip="include"]
"6" -> "18" [dir=forward tooltip="include"]
"6" -> "19" [dir=forward tooltip="include"]
"6" -> "20" [dir=forward tooltip="include"]
"6" -> "21" [dir=forward tooltip="include"]
"6" -> "24" [dir=forward tooltip="include"]
"6" -> "25" [dir=forward tooltip="include"]
"6" -> "26" [dir=forward tooltip="include"]
"41" -> "37" [dir=forward tooltip="include"]
"41" -> "42" [dir=forward tooltip="include"]
"41" -> "3" [dir=forward tooltip="include"]
"41" -> "43" [dir=forward tooltip="include"]
"43" -> "10" [dir=forward tooltip="include"]
"43" -> "12" [dir=forward tooltip="include"]
"43" -> "31" [dir=forward tooltip="include"]
"34" -> "15" [dir=forward tooltip="include"]
"34" -> "35" [dir=forward tooltip="include"]
"34" -> "5" [dir=forward tooltip="include"]
"44" -> "15" [dir=forward tooltip="include"]
"44" -> "3" [dir=forward tooltip="include"]
"28" -> "10" [dir=forward tooltip="include"]
"28" -> "12" [dir=forward tooltip="include"]
"28" -> "22" [dir=forward tooltip="include"]
"28" -> "29" [dir=forward tooltip="include"]
"28" -> "15" [dir=forward tooltip="include"]
"28" -> "13" [dir=forward tooltip="include"]
"21" -> "10" [dir=forward tooltip="include"]
"21" -> "12" [dir=forward tooltip="include"]
"21" -> "22" [dir=forward tooltip="include"]
"21" -> "14" [dir=forward tooltip="include"]
"21" -> "23" [dir=forward tooltip="include"]
"36" -> "3" [dir=forward tooltip="include"]
"36" -> "13" [dir=forward tooltip="include"]
"36" -> "37" [dir=forward tooltip="include"]
"36" -> "38" [dir=forward tooltip="include"]
"23" -> "18" [dir=forward tooltip="include"]
"23" -> "10" [dir=forward tooltip="include"]
"23" -> "11" [dir=forward tooltip="include"]
"23" -> "12" [dir=forward tooltip="include"]
"23" -> "15" [dir=forward tooltip="include"]
}](_images/graphviz-c0190c5d2d1157ff798331edb57284e02e40c89d.png)
- file ParticleIterator.H
- #include <ParticleReader.H>#include <functional>
Include dependency graph for ParticleIterator.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/expui/ParticleIterator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/ParticleIterator.H" fillcolor="#BFBFBF"]
"20" [label="Particle.H" tooltip="Particle.H"]
"2" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"16" [label="StringTok.H" tooltip="StringTok.H"]
"21" [label="gadget.H" tooltip="gadget.H"]
"17" [label="header.H" tooltip="header.H"]
"19" [label="localmpi.H" tooltip="localmpi.H"]
"22" [label="tipsy.H" tooltip="tipsy.H"]
"5" [label="algorithm" tooltip="algorithm"]
"12" [label="cmath" tooltip="cmath"]
"15" [label="config_exp.h" tooltip="config_exp.h"]
"7" [label="fstream" tooltip="fstream"]
"23" [label="functional" tooltip="functional"]
"8" [label="iomanip" tooltip="iomanip"]
"6" [label="iostream" tooltip="iostream"]
"13" [label="list" tooltip="list"]
"10" [label="memory" tooltip="memory"]
"14" [label="mpi.h" tooltip="mpi.h"]
"18" [label="sstream" tooltip="sstream"]
"4" [label="stdexcept" tooltip="stdexcept"]
"11" [label="string" tooltip="string"]
"3" [label="unordered_map" tooltip="unordered_map"]
"9" [label="vector" tooltip="vector"]
"1" -> "2" [dir=forward tooltip="include"]
"1" -> "23" [dir=forward tooltip="include"]
"20" -> "3" [dir=forward tooltip="include"]
"20" -> "9" [dir=forward tooltip="include"]
"20" -> "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" -> "13" [dir=forward tooltip="include"]
"2" -> "14" [dir=forward tooltip="include"]
"2" -> "15" [dir=forward tooltip="include"]
"2" -> "16" [dir=forward tooltip="include"]
"2" -> "17" [dir=forward tooltip="include"]
"2" -> "20" [dir=forward tooltip="include"]
"2" -> "21" [dir=forward tooltip="include"]
"2" -> "22" [dir=forward tooltip="include"]
"17" -> "6" [dir=forward tooltip="include"]
"17" -> "8" [dir=forward tooltip="include"]
"17" -> "18" [dir=forward tooltip="include"]
"17" -> "10" [dir=forward tooltip="include"]
"17" -> "19" [dir=forward tooltip="include"]
"19" -> "14" [dir=forward tooltip="include"]
"19" -> "6" [dir=forward tooltip="include"]
"19" -> "7" [dir=forward tooltip="include"]
"19" -> "8" [dir=forward tooltip="include"]
"19" -> "11" [dir=forward tooltip="include"]
}](_images/graphviz-541746c5063fcd6732a5aaa37d21da46b760c8a2.png)
- file RedSVD.H
- #include <Eigen/Sparse>#include <Eigen/Dense>#include <Eigen/Eigenvalues>#include <cstdlib>#include <cmath>
Include dependency graph for RedSVD.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/expui/RedSVD.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/RedSVD.H" fillcolor="#BFBFBF"]
"3" [label="Eigen/Dense" tooltip="Eigen/Dense"]
"4" [label="Eigen/Eigenvalues" tooltip="Eigen/Eigenvalues"]
"2" [label="Eigen/Sparse" tooltip="Eigen/Sparse"]
"6" [label="cmath" tooltip="cmath"]
"5" [label="cstdlib" tooltip="cstdlib"]
"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"]
}](_images/graphviz-7e735414fb56a3b8f142f96a43da885011bc9fe8.png)
- file GaussCore.h
- file Hermite.h
- file Jacobi.h
Functions
-
void Jacobi(int n, double alpha, double beta, double abscis[], double weight[])
-
void Lobatto_Jacobi(int n, double alpha, double beta, double abscis[], double weight[], double *leftw, double *rightw)
-
void Radau_Jacobi(int n, double alpha, double beta, double abscis[], double weight[], double *leftw)
-
void Jacobi(int n, double alpha, double beta, double abscis[], double weight[])
- file Laguerre.h
- 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"]
}](_images/graphviz-c22773aa4fe51e821ec314cb2847919c4df7f85e.png)
Typedefs
-
typedef std::shared_ptr<AsciiHisto<double>> ahistoDPtr
-
typedef std::shared_ptr<AsciiHisto<int>> ahistoIPtr
-
typedef std::shared_ptr<AsciiHisto<unsigned>> ahistoUPtr
-
typedef std::shared_ptr<AsciiHisto<double>> ahistoDPtr
- 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"]
}](_images/graphviz-f66aa41b11470e3c1c9cbe1469137f275b179a8f.png)
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"]
}](_images/graphviz-ef92933aa62b82009c3c15a3680c91e8de47db7d.png)
- 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"]
}](_images/graphviz-61a06c52930f2d89f52d47e3acc6fdb22df7b01b.png)
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"]
}](_images/graphviz-a1a6ca4017bbcac7fc2647c53330f9f72997c180.png)
Typedefs
-
typedef std::shared_ptr<AxiSymBiorth> AxiSymBioPtr
Enums
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)
-
typedef std::shared_ptr<AxiSymBiorth> AxiSymBioPtr
- 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"]
}](_images/graphviz-560d3b5f5973552c42409b96166785c932dca60f.png)
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"]
}](_images/graphviz-a41a4b0aaaef4599f5090bf19f0296b8a6cb18cf.png)
- 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"]
}](_images/graphviz-3998a995633d78cc4d32b15408e64f8c08571939.png)
- 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"]
}](_images/graphviz-6553dcec0827bcc219d2a2e26e10c2995b975bfb.png)
- 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"]
}](_images/graphviz-01d419e3f442a939439919b21bc5193488dae2e1.png)
This graph shows which files directly or indirectly include BiorthCube.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/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"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"]
"1" -> "2" [dir=back tooltip="include"]
}](_images/graphviz-ad54fd133cf40d42d01dd0fad8c5403687bd41e1.png)
- 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"]
}](_images/graphviz-c170fea2791bcb40c479e081392a0166d9032b37.png)
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"]
"2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"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"]
"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"]
"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"]
"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"]
"6" [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"]
"7" [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" -> "4" [dir=back tooltip="include"]
"1" -> "6" [dir=back tooltip="include"]
"4" -> "5" [dir=back tooltip="include"]
"4" -> "3" [dir=back tooltip="include"]
"6" -> "7" [dir=back tooltip="include"]
}](_images/graphviz-87e55829569efda46753c82f9e0b1f17ae4d22cc.png)
- 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"]
}](_images/graphviz-4db9a18c6d2f866561e41157ce3de5535ef7fe81.png)
- 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"]
}](_images/graphviz-74ca9132abaf2e77a07ed02106fa5ee1f3c128a4.png)
- 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"]
}](_images/graphviz-90f4d89c9703d5ea1e15e43903cc24f35f1c6b90.png)
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"]
}](_images/graphviz-3b6c198a11da64acfd4280feb5ffddb135c2af78.png)
- 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"]
}](_images/graphviz-01378b68da3a108c4887a112621e0d4f1b35d0e0.png)
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"]
}](_images/graphviz-aa0111bb5751f99ab2c676e20d0d87259f2a891b.png)
- 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"]
}](_images/graphviz-b2460103261d5dc3eb491465206b6102532b97df.png)
- 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/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.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"]
"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"]
"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"]
"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"]
"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"]
"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"]
"4" -> "5" [dir=back tooltip="include"]
"2" -> "3" [dir=back tooltip="include"]
"2" -> "4" [dir=back tooltip="include"]
"2" -> "6" [dir=back tooltip="include"]
"2" -> "11" [dir=back tooltip="include"]
"2" -> "5" [dir=back tooltip="include"]
"2" -> "12" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"6" -> "7" [dir=back tooltip="include"]
"7" -> "8" [dir=back tooltip="include"]
"8" -> "9" [dir=back tooltip="include"]
"8" -> "10" [dir=back tooltip="include"]
}](_images/graphviz-b65e85e9c631d332dac7c13ee9258866b9c4adbe.png)
- 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"]
}](_images/graphviz-fb7d0d53e3742c52528b511a24134578d4f1edd7.png)
- 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"]
}](_images/graphviz-9f96ff4516aaf21430bd32f16c052db140b207f0.png)
- 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"]
}](_images/graphviz-a0b5c1c455c8310e8c8926d1c4e51fb2cadeb23e.png)
- 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"]
}](_images/graphviz-10b339daba33fbf4ff0f5a232083d72999c390b6.png)
- 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"]
}](_images/graphviz-1754cae057d9ff295a5d9c00ad4a398f723aabd1.png)
- 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"]
}](_images/graphviz-34829ffe37de1dcb54f3676d23c168706675b5ec.png)
- 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"]
}](_images/graphviz-51fd1c759b33efe5d3f5bcd8502c100efaa2c254.png)
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"]
}](_images/graphviz-0a0742d243617ef7749479df552da27f505d9847.png)
- 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"]
}](_images/graphviz-f6782379f5a29f15032ae52238b943be9d989cfe.png)
- 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"]
}](_images/graphviz-101472c7deb24ad5d53c92586e0531c3948a9060.png)
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"]
"2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"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"]
"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"]
"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"]
"3" -> "4" [dir=back tooltip="include"]
}](_images/graphviz-5cbf2c055f82d387ee1c09f2f94b182e183a9fe1.png)
- 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"]
}](_images/graphviz-e25e59ad1d4eabb8dd1d43674a63cd47db399fe9.png)
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"]
}](_images/graphviz-33706eae452ef87eed062b110abca248cf43cbbf.png)
- 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"]
}](_images/graphviz-0b8547e55cf2f70a5483858cf0551b0f14eb1216.png)
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"]
"5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"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"]
"6" [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"]
"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"]
"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"]
"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"]
"9" [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"]
"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"]
"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"]
"8" [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"]
"10" [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"]
"11" [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"]
"4" -> "5" [dir=back tooltip="include"]
"6" -> "5" [dir=back tooltip="include"]
"6" -> "7" [dir=back tooltip="include"]
"6" -> "8" [dir=back tooltip="include"]
"6" -> "10" [dir=back tooltip="include"]
"16" -> "17" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"15" -> "5" [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" -> "5" [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" -> "11" [dir=back tooltip="include"]
"30" -> "24" [dir=back tooltip="include"]
"32" -> "13" [dir=back tooltip="include"]
"3" -> "4" [dir=back tooltip="include"]
"3" -> "6" [dir=back tooltip="include"]
"3" -> "1" [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" -> "11" [dir=back tooltip="include"]
"3" -> "24" [dir=back tooltip="include"]
"3" -> "43" [dir=back tooltip="include"]
"3" -> "44" [dir=back tooltip="include"]
"18" -> "19" [dir=back tooltip="include"]
"19" -> "20" [dir=back tooltip="include"]
"8" -> "9" [dir=back tooltip="include"]
"8" -> "7" [dir=back tooltip="include"]
"27" -> "20" [dir=back tooltip="include"]
"20" -> "21" [dir=back tooltip="include"]
"20" -> "22" [dir=back tooltip="include"]
"41" -> "11" [dir=back tooltip="include"]
"41" -> "24" [dir=back tooltip="include"]
"10" -> "11" [dir=back tooltip="include"]
"29" -> "11" [dir=back tooltip="include"]
"29" -> "24" [dir=back tooltip="include"]
}](_images/graphviz-89c3ec56a541c7a5ef46f927118c4ca625fb99e9.png)
- 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"]
}](_images/graphviz-06ebca9a4767abf08025bdaa2c7d4477723c912e.png)
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"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"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"]
"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/EmpCyl2d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/include/EmpCyl2d.H" fillcolor="#BFBFBF"]
"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"]
"2" -> "3" [dir=back tooltip="include"]
"4" -> "3" [dir=back tooltip="include"]
"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" -> "4" [dir=back tooltip="include"]
"6" -> "7" [dir=back tooltip="include"]
"6" -> "5" [dir=back tooltip="include"]
"8" -> "9" [dir=back tooltip="include"]
}](_images/graphviz-6b35abee5c1644cc01ca65e957b25724bdf0979f.png)
- 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"]
}](_images/graphviz-f640501b599845affca1f5b98dc0c7eea6b63f2b.png)
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/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.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"]
"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"]
"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"]
"1" -> "2" [dir=back tooltip="include"]
"1" -> "3" [dir=back tooltip="include"]
"1" -> "5" [dir=back tooltip="include"]
"1" -> "10" [dir=back tooltip="include"]
"1" -> "4" [dir=back tooltip="include"]
"1" -> "11" [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"]
}](_images/graphviz-9826f982131a0cbd93defdd5f753adea91841994.png)
- 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"]
}](_images/graphviz-4e3f41363c41b77453923cde1fcecd7b4f873bde.png)
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"]
}](_images/graphviz-e9c6e89ef5942f0bd00faaaed8539050dfb4df66.png)
- 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"]
}](_images/graphviz-6bb0fb275cc333981b0aadb1cde32c39e9f1ffc4.png)
- 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"]
}](_images/graphviz-6e6cacb9a4a65100961a46aa6f86b8a4b09f04c2.png)
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)
-
void exp_thread_fork(void *(*func)(void*), char *caller)
- 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"]
}](_images/graphviz-bcb50282330f7c3589ca2904df52c58d2dfcd905.png)
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"]
}](_images/graphviz-3febabe959f959add2b14bf95645000dd7b6eceb.png)
- 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"]
}](_images/graphviz-18357504dc1e9ae4bd0e59a57e46103ad05d8423.png)
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.
-
cxxopts::ParseResult LoadConfig(cxxopts::Options &options, const std::string &config)
- 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"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"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"]
"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"]
"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"]
"12" [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"]
"11" [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"]
"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"]
"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"]
"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"]
"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"]
"13" [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"]
"3" -> "4" [dir=back tooltip="include"]
"5" -> "4" [dir=back tooltip="include"]
"5" -> "6" [dir=back tooltip="include"]
"5" -> "7" [dir=back tooltip="include"]
"5" -> "9" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"1" -> "11" [dir=back tooltip="include"]
"1" -> "13" [dir=back tooltip="include"]
"2" -> "3" [dir=back tooltip="include"]
"2" -> "5" [dir=back tooltip="include"]
"11" -> "12" [dir=back tooltip="include"]
"7" -> "8" [dir=back tooltip="include"]
"7" -> "6" [dir=back tooltip="include"]
"9" -> "10" [dir=back tooltip="include"]
}](_images/graphviz-4b9d79ae92da58b6f4f3e60e8f7adb29ca2e51b4.png)
- 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"]
}](_images/graphviz-791f715c72b72437ecd68898d59f413cd97ef74f.png)
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"]
}](_images/graphviz-026fb6505180a11f92c0e4217c8aeab9f9d71885.png)
- 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"]
}](_images/graphviz-c174aa80c8bb605557243c47e4ed308b6ddc8a05.png)
This graph shows which files directly or indirectly include exputils.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/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"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"]
"5" [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"]
"2" -> "3" [dir=back tooltip="include"]
"2" -> "4" [dir=back tooltip="include"]
"2" -> "6" [dir=back tooltip="include"]
"2" -> "7" [dir=back tooltip="include"]
"4" -> "5" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"1" -> "3" [dir=back tooltip="include"]
}](_images/graphviz-830bc05125cc7c500c356fa52fd2d58c641e7a8d.png)
- 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"]
}](_images/graphviz-7be09a210d2c10057a4543192db7b70ca9dd437c.png)
- 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"]
}](_images/graphviz-c698503801924fa6c81565e65b0eea0771379787.png)
- 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"]
}](_images/graphviz-88f66d6aa2a9071f2a4144ebfd9c73647bf07acf.png)
- 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"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Centering.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Centering.H"]
"5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/ParticleIterator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/ParticleIterator.H"]
"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"]
"11" [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"]
"12" [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"]
"23" [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"]
"24" [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"]
"26" [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"]
"13" [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"]
"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"]
"27" [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"]
"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"]
"6" [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"]
"14" [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"]
"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"]
"28" [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/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
"22" [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"]
"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"]
"21" [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" -> "7" [dir=back tooltip="include"]
"3" -> "8" [dir=back tooltip="include"]
"5" -> "6" [dir=back tooltip="include"]
"2" -> "3" [dir=back tooltip="include"]
"2" -> "4" [dir=back tooltip="include"]
"2" -> "9" [dir=back tooltip="include"]
"2" -> "5" [dir=back tooltip="include"]
"2" -> "8" [dir=back tooltip="include"]
"2" -> "10" [dir=back tooltip="include"]
"2" -> "11" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"11" -> "12" [dir=back tooltip="include"]
"11" -> "29" [dir=back tooltip="include"]
"11" -> "33" [dir=back tooltip="include"]
"11" -> "34" [dir=back tooltip="include"]
"11" -> "35" [dir=back tooltip="include"]
"11" -> "6" [dir=back tooltip="include"]
"12" -> "13" [dir=back tooltip="include"]
"12" -> "22" [dir=back tooltip="include"]
"23" -> "24" [dir=back tooltip="include"]
"24" -> "25" [dir=back tooltip="include"]
"13" -> "14" [dir=back tooltip="include"]
"13" -> "15" [dir=back tooltip="include"]
"13" -> "16" [dir=back tooltip="include"]
"13" -> "17" [dir=back tooltip="include"]
"13" -> "18" [dir=back tooltip="include"]
"13" -> "19" [dir=back tooltip="include"]
"13" -> "20" [dir=back tooltip="include"]
"13" -> "21" [dir=back tooltip="include"]
"29" -> "13" [dir=back tooltip="include"]
"29" -> "30" [dir=back tooltip="include"]
"29" -> "31" [dir=back tooltip="include"]
"29" -> "22" [dir=back tooltip="include"]
"29" -> "32" [dir=back tooltip="include"]
"33" -> "33" [dir=back tooltip="include"]
"25" -> "26" [dir=back tooltip="include"]
"25" -> "27" [dir=back tooltip="include"]
"22" -> "23" [dir=back tooltip="include"]
"22" -> "28" [dir=back tooltip="include"]
}](_images/graphviz-5d7f47f942ec7837b219a1118e49257f8858fe9c.png)
- 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"]
}](_images/graphviz-b03625583d541c0d4227b2f2d22c6aafbeaa21b7.png)
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"]
"22" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"23" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"25" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"26" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"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"]
"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"]
"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"]
"30" [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"]
"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"]
"31" [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"]
"32" [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"]
"21" [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"]
"28" [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"]
"33" [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"]
"39" [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"]
"40" [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"]
"41" [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"]
"42" [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"]
"43" [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"]
"29" [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"]
"44" [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"]
"27" [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"]
"45" [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"]
"34" [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"]
"46" [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"]
"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"]
"47" [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"]
"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"]
"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"]
"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/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/PolarBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PolarBasis.H"]
"48" [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"]
"35" [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"]
"36" [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"]
"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"]
"49" [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"]
"37" [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"]
"50" [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"]
"51" [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"]
"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"]
"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"]
"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/EllipForce.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/EllipForce.H"]
"55" [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"]
"38" [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"]
"52" [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"]
"53" [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"]
"22" -> "4" [dir=back tooltip="include"]
"22" -> "23" [dir=back tooltip="include"]
"22" -> "25" [dir=back tooltip="include"]
"22" -> "26" [dir=back tooltip="include"]
"23" -> "24" [dir=back tooltip="include"]
"3" -> "4" [dir=back tooltip="include"]
"5" -> "4" [dir=back tooltip="include"]
"5" -> "6" [dir=back tooltip="include"]
"5" -> "7" [dir=back tooltip="include"]
"5" -> "9" [dir=back tooltip="include"]
"12" -> "13" [dir=back tooltip="include"]
"30" -> "28" [dir=back tooltip="include"]
"2" -> "3" [dir=back tooltip="include"]
"2" -> "5" [dir=back tooltip="include"]
"11" -> "4" [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"]
"21" -> "22" [dir=back tooltip="include"]
"21" -> "23" [dir=back tooltip="include"]
"21" -> "26" [dir=back tooltip="include"]
"28" -> "29" [dir=back tooltip="include"]
"33" -> "4" [dir=back tooltip="include"]
"33" -> "11" [dir=back tooltip="include"]
"33" -> "34" [dir=back tooltip="include"]
"33" -> "35" [dir=back tooltip="include"]
"33" -> "36" [dir=back tooltip="include"]
"33" -> "16" [dir=back tooltip="include"]
"33" -> "37" [dir=back tooltip="include"]
"33" -> "38" [dir=back tooltip="include"]
"39" -> "10" [dir=back tooltip="include"]
"39" -> "20" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"1" -> "11" [dir=back tooltip="include"]
"1" -> "21" [dir=back tooltip="include"]
"1" -> "27" [dir=back tooltip="include"]
"1" -> "9" [dir=back tooltip="include"]
"1" -> "10" [dir=back tooltip="include"]
"1" -> "13" [dir=back tooltip="include"]
"1" -> "20" [dir=back tooltip="include"]
"1" -> "54" [dir=back tooltip="include"]
"1" -> "55" [dir=back tooltip="include"]
"41" -> "32" [dir=back tooltip="include"]
"29" -> "3" [dir=back tooltip="include"]
"29" -> "5" [dir=back tooltip="include"]
"29" -> "30" [dir=back tooltip="include"]
"29" -> "31" [dir=back tooltip="include"]
"29" -> "32" [dir=back tooltip="include"]
"29" -> "28" [dir=back tooltip="include"]
"29" -> "33" [dir=back tooltip="include"]
"29" -> "39" [dir=back tooltip="include"]
"29" -> "40" [dir=back tooltip="include"]
"29" -> "41" [dir=back tooltip="include"]
"29" -> "42" [dir=back tooltip="include"]
"29" -> "43" [dir=back tooltip="include"]
"29" -> "44" [dir=back tooltip="include"]
"29" -> "45" [dir=back tooltip="include"]
"29" -> "46" [dir=back tooltip="include"]
"29" -> "47" [dir=back tooltip="include"]
"29" -> "48" [dir=back tooltip="include"]
"29" -> "49" [dir=back tooltip="include"]
"29" -> "50" [dir=back tooltip="include"]
"29" -> "51" [dir=back tooltip="include"]
"29" -> "19" [dir=back tooltip="include"]
"29" -> "10" [dir=back tooltip="include"]
"29" -> "20" [dir=back tooltip="include"]
"29" -> "52" [dir=back tooltip="include"]
"29" -> "53" [dir=back tooltip="include"]
"27" -> "28" [dir=back tooltip="include"]
"27" -> "29" [dir=back tooltip="include"]
"27" -> "49" [dir=back tooltip="include"]
"14" -> "15" [dir=back tooltip="include"]
"15" -> "16" [dir=back tooltip="include"]
"7" -> "8" [dir=back tooltip="include"]
"7" -> "6" [dir=back tooltip="include"]
"36" -> "16" [dir=back tooltip="include"]
"16" -> "17" [dir=back tooltip="include"]
"16" -> "18" [dir=back tooltip="include"]
"50" -> "10" [dir=back tooltip="include"]
"50" -> "20" [dir=back tooltip="include"]
"9" -> "10" [dir=back tooltip="include"]
"38" -> "10" [dir=back tooltip="include"]
"38" -> "20" [dir=back tooltip="include"]
}](_images/graphviz-8aed0fa5e4857db9f334414a22c8e03d7e22f2d9.png)
- 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"]
}](_images/graphviz-137033046ae30a9233bdabcd642be63722c4ac75.png)
- file gknots.h
- 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"]
}](_images/graphviz-83978abcef4ca2a29941c6ab55e87f6662f44220.png)
- 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"]
}](_images/graphviz-4c7e72a38b354cef8543fe3e038237f13964c807.png)
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"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Centering.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Centering.H"]
"5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/ParticleIterator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/ParticleIterator.H"]
"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"]
"11" [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"]
"12" [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"]
"23" [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"]
"24" [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"]
"26" [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"]
"13" [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"]
"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"]
"27" [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"]
"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"]
"6" [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"]
"14" [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"]
"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"]
"28" [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/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
"22" [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"]
"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"]
"21" [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"]
"36" [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"]
"37" [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"]
"3" -> "8" [dir=back tooltip="include"]
"5" -> "6" [dir=back tooltip="include"]
"2" -> "3" [dir=back tooltip="include"]
"2" -> "4" [dir=back tooltip="include"]
"2" -> "9" [dir=back tooltip="include"]
"2" -> "5" [dir=back tooltip="include"]
"2" -> "8" [dir=back tooltip="include"]
"2" -> "10" [dir=back tooltip="include"]
"2" -> "11" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"1" -> "11" [dir=back tooltip="include"]
"1" -> "36" [dir=back tooltip="include"]
"1" -> "37" [dir=back tooltip="include"]
"11" -> "12" [dir=back tooltip="include"]
"11" -> "29" [dir=back tooltip="include"]
"11" -> "33" [dir=back tooltip="include"]
"11" -> "34" [dir=back tooltip="include"]
"11" -> "35" [dir=back tooltip="include"]
"11" -> "6" [dir=back tooltip="include"]
"12" -> "13" [dir=back tooltip="include"]
"12" -> "22" [dir=back tooltip="include"]
"23" -> "24" [dir=back tooltip="include"]
"24" -> "25" [dir=back tooltip="include"]
"13" -> "14" [dir=back tooltip="include"]
"13" -> "15" [dir=back tooltip="include"]
"13" -> "16" [dir=back tooltip="include"]
"13" -> "17" [dir=back tooltip="include"]
"13" -> "18" [dir=back tooltip="include"]
"13" -> "19" [dir=back tooltip="include"]
"13" -> "20" [dir=back tooltip="include"]
"13" -> "21" [dir=back tooltip="include"]
"29" -> "13" [dir=back tooltip="include"]
"29" -> "30" [dir=back tooltip="include"]
"29" -> "31" [dir=back tooltip="include"]
"29" -> "22" [dir=back tooltip="include"]
"29" -> "32" [dir=back tooltip="include"]
"33" -> "33" [dir=back tooltip="include"]
"25" -> "26" [dir=back tooltip="include"]
"25" -> "27" [dir=back tooltip="include"]
"22" -> "23" [dir=back tooltip="include"]
"22" -> "28" [dir=back tooltip="include"]
}](_images/graphviz-3617b2ab282cbd3a20016543b7f383858cb0adcd.png)
- 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"]
}](_images/graphviz-6c11202b00d7820fc71a2aa7a1688ae9d73b8997.png)
- 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"]
}](_images/graphviz-a8a7762eee42624046aef056cab59146df8262d1.png)
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"]
}](_images/graphviz-8503503ff6e37978e9e37bc4b88d3cf4de26832f.png)
- 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"]
}](_images/graphviz-ca24f27c86d46d0233f2ae2b237fb1d2e0356703.png)
- 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"]
}](_images/graphviz-096dc643ad1689abac1607e58d27c395fce53dbe.png)
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.
-
template<template<class, class, class...> class C, typename K, typename V, typename ...Args>
- file interp.H
- #include <Eigen/Eigen>#include <vector>#include <deque>#include <MonotCubicInterpolator.H>
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"]
}](_images/graphviz-1040039653c8c87945f6a67af377a4ccb561630d.png)
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"]
"2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"20" [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"]
"21" [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"]
"9" [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"]
"27" [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"]
"8" [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"]
"29" [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"]
"30" [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"]
"28" [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"]
"31" [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"]
"37" [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"]
"38" [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"]
"39" [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"]
"18" [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"]
"40" [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"]
"19" [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"]
"41" [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"]
"42" [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"]
"32" [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"]
"43" [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"]
"24" [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"]
"11" [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"]
"12" [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"]
"44" [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"]
"22" [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"]
"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"]
"5" [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"]
"23" [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"]
"45" [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"]
"33" [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"]
"34" [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"]
"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"]
"46" [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"]
"35" [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"]
"47" [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"]
"48" [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"]
"16" [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"]
"25" [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"]
"26" [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"]
"10" [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"]
"17" [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"]
"51" [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"]
"52" [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"]
"36" [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"]
"49" [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"]
"50" [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"]
"2" -> "3" [dir=back tooltip="include"]
"2" -> "4" [dir=back tooltip="include"]
"2" -> "6" [dir=back tooltip="include"]
"2" -> "7" [dir=back tooltip="include"]
"4" -> "5" [dir=back tooltip="include"]
"20" -> "3" [dir=back tooltip="include"]
"21" -> "3" [dir=back tooltip="include"]
"21" -> "22" [dir=back tooltip="include"]
"21" -> "23" [dir=back tooltip="include"]
"21" -> "25" [dir=back tooltip="include"]
"9" -> "10" [dir=back tooltip="include"]
"27" -> "28" [dir=back tooltip="include"]
"8" -> "3" [dir=back tooltip="include"]
"8" -> "9" [dir=back tooltip="include"]
"8" -> "11" [dir=back tooltip="include"]
"8" -> "16" [dir=back tooltip="include"]
"8" -> "10" [dir=back tooltip="include"]
"8" -> "17" [dir=back tooltip="include"]
"28" -> "19" [dir=back tooltip="include"]
"31" -> "3" [dir=back tooltip="include"]
"31" -> "8" [dir=back tooltip="include"]
"31" -> "32" [dir=back tooltip="include"]
"31" -> "33" [dir=back tooltip="include"]
"31" -> "34" [dir=back tooltip="include"]
"31" -> "13" [dir=back tooltip="include"]
"31" -> "35" [dir=back tooltip="include"]
"31" -> "36" [dir=back tooltip="include"]
"37" -> "26" [dir=back tooltip="include"]
"37" -> "17" [dir=back tooltip="include"]
"39" -> "30" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"1" -> "4" [dir=back tooltip="include"]
"1" -> "7" [dir=back tooltip="include"]
"1" -> "8" [dir=back tooltip="include"]
"1" -> "18" [dir=back tooltip="include"]
"1" -> "19" [dir=back tooltip="include"]
"1" -> "5" [dir=back tooltip="include"]
"1" -> "45" [dir=back tooltip="include"]
"1" -> "16" [dir=back tooltip="include"]
"1" -> "51" [dir=back tooltip="include"]
"1" -> "52" [dir=back tooltip="include"]
"19" -> "20" [dir=back tooltip="include"]
"19" -> "21" [dir=back tooltip="include"]
"19" -> "27" [dir=back tooltip="include"]
"19" -> "29" [dir=back tooltip="include"]
"19" -> "30" [dir=back tooltip="include"]
"19" -> "28" [dir=back tooltip="include"]
"19" -> "31" [dir=back tooltip="include"]
"19" -> "37" [dir=back tooltip="include"]
"19" -> "38" [dir=back tooltip="include"]
"19" -> "39" [dir=back tooltip="include"]
"19" -> "18" [dir=back tooltip="include"]
"19" -> "40" [dir=back tooltip="include"]
"19" -> "41" [dir=back tooltip="include"]
"19" -> "42" [dir=back tooltip="include"]
"19" -> "43" [dir=back tooltip="include"]
"19" -> "44" [dir=back tooltip="include"]
"19" -> "45" [dir=back tooltip="include"]
"19" -> "46" [dir=back tooltip="include"]
"19" -> "47" [dir=back tooltip="include"]
"19" -> "48" [dir=back tooltip="include"]
"19" -> "16" [dir=back tooltip="include"]
"19" -> "26" [dir=back tooltip="include"]
"19" -> "17" [dir=back tooltip="include"]
"19" -> "49" [dir=back tooltip="include"]
"19" -> "50" [dir=back tooltip="include"]
"11" -> "12" [dir=back tooltip="include"]
"12" -> "13" [dir=back tooltip="include"]
"23" -> "24" [dir=back tooltip="include"]
"23" -> "22" [dir=back tooltip="include"]
"34" -> "13" [dir=back tooltip="include"]
"13" -> "14" [dir=back tooltip="include"]
"13" -> "15" [dir=back tooltip="include"]
"47" -> "26" [dir=back tooltip="include"]
"47" -> "17" [dir=back tooltip="include"]
"25" -> "26" [dir=back tooltip="include"]
"36" -> "26" [dir=back tooltip="include"]
"36" -> "17" [dir=back tooltip="include"]
}](_images/graphviz-ee206faa7a2f0a54596eaf888073091d57bef8dd.png)
Functions
-
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 Spline(const Eigen::VectorXd &x, const Eigen::VectorXd &y, double yp1, double ypn, Eigen::VectorXd &y2)
- 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"]
}](_images/graphviz-f4262d948b4641c37a0a0e7a3fcaf5a65dcdb556.png)
- 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"]
}](_images/graphviz-833411871646b633a3bcb4380109703c9e13db4c.png)
- 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"]
}](_images/graphviz-7a6214804ea9062e09a0863b0befbcd3ae0d187e.png)
- 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"]
}](_images/graphviz-849c8d3acf98f564fba077e2dfdc927959f5aa91.png)
- 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"]
}](_images/graphviz-fb381343129cad7715f3592f774a86ced44cd6a2.png)
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/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.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"]
"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"]
"35" [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"]
"36" [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"]
"37" [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"]
"38" [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"]
"42" [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"]
"39" [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"]
"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"]
"41" [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"]
"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"]
"40" [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"]
"31" -> "32" [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" -> "31" [dir=back tooltip="include"]
"29" -> "15" [dir=back tooltip="include"]
"29" -> "33" [dir=back tooltip="include"]
"29" -> "32" [dir=back tooltip="include"]
"29" -> "34" [dir=back tooltip="include"]
"35" -> "30" [dir=back tooltip="include"]
"35" -> "29" [dir=back tooltip="include"]
"35" -> "36" [dir=back tooltip="include"]
"35" -> "37" [dir=back tooltip="include"]
"35" -> "38" [dir=back tooltip="include"]
"35" -> "17" [dir=back tooltip="include"]
"35" -> "39" [dir=back tooltip="include"]
"35" -> "40" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"1" -> "29" [dir=back tooltip="include"]
"1" -> "35" [dir=back tooltip="include"]
"1" -> "42" [dir=back tooltip="include"]
"1" -> "41" [dir=back tooltip="include"]
"1" -> "34" [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"]
"38" -> "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"]
"42" -> "3" [dir=back tooltip="include"]
"42" -> "15" [dir=back tooltip="include"]
"42" -> "14" [dir=back tooltip="include"]
"40" -> "41" [dir=back tooltip="include"]
"40" -> "34" [dir=back tooltip="include"]
}](_images/graphviz-5941c95ee37beb0a186c7bb76d6036fc3a2110fb.png)
- 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"]
}](_images/graphviz-7a787bdecf8eb7e083c38b16257efc95dcc4d820.png)
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/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"34" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Centering.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Centering.H"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"35" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/ParticleIterator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/ParticleIterator.H"]
"8" [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"]
"9" [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"]
"18" [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"]
"15" [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"]
"17" [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"]
"33" [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"]
"16" [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/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"]
"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"]
"12" [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"]
"36" [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"]
"37" [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"]
"20" [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"]
"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"]
"23" [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"]
"38" [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"]
"49" [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"]
"10" [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"]
"50" [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"]
"24" [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"]
"53" [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"]
"54" [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"]
"55" [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/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
"58" [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"]
"39" [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"]
"11" [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"]
"51" [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"]
"48" [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"]
"59" [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"]
"22" [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"]
"47" [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"]
"60" [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"]
"40" [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"]
"41" [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"]
"42" [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"]
"43" [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"]
"44" [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"]
"45" [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"]
"46" [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"]
"52" [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"]
"56" [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/Analysis/SphSL.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis/SphSL.H"]
"25" [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"]
"13" [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"]
"14" [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"]
"19" [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"]
"26" [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"]
"61" [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"]
"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"]
"57" [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"]
"2" -> "3" [dir=back tooltip="include"]
"2" -> "4" [dir=back tooltip="include"]
"2" -> "6" [dir=back tooltip="include"]
"2" -> "7" [dir=back tooltip="include"]
"4" -> "5" [dir=back tooltip="include"]
"8" -> "3" [dir=back tooltip="include"]
"9" -> "3" [dir=back tooltip="include"]
"9" -> "10" [dir=back tooltip="include"]
"9" -> "11" [dir=back tooltip="include"]
"9" -> "13" [dir=back tooltip="include"]
"18" -> "19" [dir=back tooltip="include"]
"15" -> "8" [dir=back tooltip="include"]
"15" -> "9" [dir=back tooltip="include"]
"17" -> "3" [dir=back tooltip="include"]
"17" -> "18" [dir=back tooltip="include"]
"17" -> "20" [dir=back tooltip="include"]
"17" -> "25" [dir=back tooltip="include"]
"17" -> "19" [dir=back tooltip="include"]
"17" -> "26" [dir=back tooltip="include"]
"33" -> "2" [dir=back tooltip="include"]
"33" -> "3" [dir=back tooltip="include"]
"33" -> "34" [dir=back tooltip="include"]
"33" -> "4" [dir=back tooltip="include"]
"33" -> "7" [dir=back tooltip="include"]
"33" -> "35" [dir=back tooltip="include"]
"33" -> "36" [dir=back tooltip="include"]
"16" -> "3" [dir=back tooltip="include"]
"16" -> "17" [dir=back tooltip="include"]
"16" -> "27" [dir=back tooltip="include"]
"16" -> "28" [dir=back tooltip="include"]
"16" -> "29" [dir=back tooltip="include"]
"16" -> "22" [dir=back tooltip="include"]
"16" -> "30" [dir=back tooltip="include"]
"16" -> "31" [dir=back tooltip="include"]
"32" -> "33" [dir=back tooltip="include"]
"32" -> "36" [dir=back tooltip="include"]
"32" -> "56" [dir=back tooltip="include"]
"32" -> "57" [dir=back tooltip="include"]
"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" -> "9" [dir=back tooltip="include"]
"1" -> "15" [dir=back tooltip="include"]
"1" -> "16" [dir=back tooltip="include"]
"1" -> "32" [dir=back tooltip="include"]
"1" -> "36" [dir=back tooltip="include"]
"1" -> "58" [dir=back tooltip="include"]
"1" -> "59" [dir=back tooltip="include"]
"1" -> "60" [dir=back tooltip="include"]
"1" -> "30" [dir=back tooltip="include"]
"1" -> "14" [dir=back tooltip="include"]
"1" -> "26" [dir=back tooltip="include"]
"1" -> "61" [dir=back tooltip="include"]
"36" -> "37" [dir=back tooltip="include"]
"36" -> "49" [dir=back tooltip="include"]
"36" -> "53" [dir=back tooltip="include"]
"36" -> "54" [dir=back tooltip="include"]
"36" -> "55" [dir=back tooltip="include"]
"36" -> "5" [dir=back tooltip="include"]
"37" -> "38" [dir=back tooltip="include"]
"37" -> "47" [dir=back tooltip="include"]
"20" -> "21" [dir=back tooltip="include"]
"21" -> "22" [dir=back tooltip="include"]
"38" -> "39" [dir=back tooltip="include"]
"38" -> "40" [dir=back tooltip="include"]
"38" -> "41" [dir=back tooltip="include"]
"38" -> "42" [dir=back tooltip="include"]
"38" -> "43" [dir=back tooltip="include"]
"38" -> "44" [dir=back tooltip="include"]
"38" -> "45" [dir=back tooltip="include"]
"38" -> "46" [dir=back tooltip="include"]
"49" -> "38" [dir=back tooltip="include"]
"49" -> "50" [dir=back tooltip="include"]
"49" -> "51" [dir=back tooltip="include"]
"49" -> "47" [dir=back tooltip="include"]
"49" -> "52" [dir=back tooltip="include"]
"53" -> "53" [dir=back tooltip="include"]
"58" -> "36" [dir=back tooltip="include"]
"11" -> "12" [dir=back tooltip="include"]
"11" -> "10" [dir=back tooltip="include"]
"29" -> "22" [dir=back tooltip="include"]
"22" -> "23" [dir=back tooltip="include"]
"22" -> "24" [dir=back tooltip="include"]
"47" -> "20" [dir=back tooltip="include"]
"47" -> "48" [dir=back tooltip="include"]
"60" -> "36" [dir=back tooltip="include"]
"60" -> "20" [dir=back tooltip="include"]
"60" -> "47" [dir=back tooltip="include"]
"13" -> "14" [dir=back tooltip="include"]
"61" -> "14" [dir=back tooltip="include"]
"61" -> "26" [dir=back tooltip="include"]
"31" -> "14" [dir=back tooltip="include"]
"31" -> "26" [dir=back tooltip="include"]
}](_images/graphviz-a52d82745484da43db149031ef66618f250c2455.png)
Functions
-
void local_init_mpi(int argc, char **argv)
Initialize MPI.
-
void local_init_mpi(int argc, char **argv)
- 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"]
}](_images/graphviz-207fdd10a1047576b186e38a938b7aed5659035b.png)
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"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"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"]
"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"]
"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"]
"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"]
"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"]
"11" [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"]
"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"]
"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"]
"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"]
"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"]
"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"]
"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"]
"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"]
"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"]
"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"]
"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"]
"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"]
"2" -> "3" [dir=back tooltip="include"]
"4" -> "3" [dir=back tooltip="include"]
"4" -> "5" [dir=back tooltip="include"]
"4" -> "6" [dir=back tooltip="include"]
"4" -> "8" [dir=back tooltip="include"]
"16" -> "17" [dir=back tooltip="include"]
"10" -> "11" [dir=back tooltip="include"]
"15" -> "3" [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"]
"11" -> "1" [dir=back tooltip="include"]
"14" -> "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" -> "9" [dir=back tooltip="include"]
"30" -> "24" [dir=back tooltip="include"]
"32" -> "13" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"1" -> "4" [dir=back tooltip="include"]
"1" -> "10" [dir=back tooltip="include"]
"1" -> "12" [dir=back tooltip="include"]
"1" -> "13" [dir=back tooltip="include"]
"1" -> "11" [dir=back tooltip="include"]
"1" -> "14" [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" -> "42" [dir=back tooltip="include"]
"1" -> "23" [dir=back tooltip="include"]
"1" -> "9" [dir=back tooltip="include"]
"1" -> "24" [dir=back tooltip="include"]
"1" -> "43" [dir=back tooltip="include"]
"1" -> "44" [dir=back tooltip="include"]
"18" -> "19" [dir=back tooltip="include"]
"19" -> "20" [dir=back tooltip="include"]
"6" -> "7" [dir=back tooltip="include"]
"6" -> "5" [dir=back tooltip="include"]
"27" -> "20" [dir=back tooltip="include"]
"20" -> "21" [dir=back tooltip="include"]
"20" -> "22" [dir=back tooltip="include"]
"41" -> "9" [dir=back tooltip="include"]
"41" -> "24" [dir=back tooltip="include"]
"8" -> "9" [dir=back tooltip="include"]
"29" -> "9" [dir=back tooltip="include"]
"29" -> "24" [dir=back tooltip="include"]
}](_images/graphviz-0b9b29cbf932c4b858743370acb3b8929b9fb958.png)
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
-
typedef std::shared_ptr<AxiSymModel> AxiSymModPtr
- 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"]
}](_images/graphviz-751f0f55caa9e7d29c03a032e1d3f7c8db0e1151.png)
- file model2d.H
Enums
Variables
-
static string Model2dNames[] = {"Mestel", "Toomre", "Exponential", "Kalnajs", "Hunter", "HunterX"}
-
static string Model2dNames[] = {"Mestel", "Toomre", "Exponential", "Kalnajs", "Hunter", "HunterX"}
- file model3d.H
Enums
- 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"]
}](_images/graphviz-36f086d76a3cfd0c754058c0737c93d9b8d36622.png)
- 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"]
}](_images/graphviz-d86e599eb73a761c6a50c3429ea6691251585815.png)
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"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"21" [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"]
"22" [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"]
"10" [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"]
"28" [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"]
"9" [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"]
"30" [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"]
"31" [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"]
"29" [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"]
"32" [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"]
"38" [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"]
"39" [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"]
"40" [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"]
"19" [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"]
"41" [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"]
"20" [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"]
"42" [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"]
"43" [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"]
"33" [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"]
"44" [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"]
"25" [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"]
"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"]
"45" [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"]
"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"]
"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"]
"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"]
"6" [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"]
"24" [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"]
"46" [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"]
"34" [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"]
"35" [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"]
"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"]
"47" [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"]
"36" [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"]
"48" [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"]
"49" [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"]
"17" [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"]
"26" [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"]
"27" [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"]
"11" [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"]
"18" [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"]
"52" [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"]
"53" [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"]
"37" [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/ICs/massmodel1d.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/massmodel1d.H"]
"51" [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"]
"3" -> "8" [dir=back tooltip="include"]
"5" -> "6" [dir=back tooltip="include"]
"21" -> "4" [dir=back tooltip="include"]
"22" -> "4" [dir=back tooltip="include"]
"22" -> "23" [dir=back tooltip="include"]
"22" -> "24" [dir=back tooltip="include"]
"22" -> "26" [dir=back tooltip="include"]
"10" -> "11" [dir=back tooltip="include"]
"28" -> "29" [dir=back tooltip="include"]
"9" -> "4" [dir=back tooltip="include"]
"9" -> "10" [dir=back tooltip="include"]
"9" -> "12" [dir=back tooltip="include"]
"9" -> "17" [dir=back tooltip="include"]
"9" -> "11" [dir=back tooltip="include"]
"9" -> "18" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"29" -> "20" [dir=back tooltip="include"]
"32" -> "4" [dir=back tooltip="include"]
"32" -> "9" [dir=back tooltip="include"]
"32" -> "33" [dir=back tooltip="include"]
"32" -> "34" [dir=back tooltip="include"]
"32" -> "35" [dir=back tooltip="include"]
"32" -> "14" [dir=back tooltip="include"]
"32" -> "36" [dir=back tooltip="include"]
"32" -> "37" [dir=back tooltip="include"]
"38" -> "27" [dir=back tooltip="include"]
"38" -> "18" [dir=back tooltip="include"]
"40" -> "31" [dir=back tooltip="include"]
"2" -> "3" [dir=back tooltip="include"]
"2" -> "5" [dir=back tooltip="include"]
"2" -> "8" [dir=back tooltip="include"]
"2" -> "9" [dir=back tooltip="include"]
"2" -> "19" [dir=back tooltip="include"]
"2" -> "20" [dir=back tooltip="include"]
"2" -> "6" [dir=back tooltip="include"]
"2" -> "46" [dir=back tooltip="include"]
"2" -> "17" [dir=back tooltip="include"]
"2" -> "52" [dir=back tooltip="include"]
"2" -> "53" [dir=back tooltip="include"]
"20" -> "21" [dir=back tooltip="include"]
"20" -> "22" [dir=back tooltip="include"]
"20" -> "28" [dir=back tooltip="include"]
"20" -> "30" [dir=back tooltip="include"]
"20" -> "31" [dir=back tooltip="include"]
"20" -> "29" [dir=back tooltip="include"]
"20" -> "32" [dir=back tooltip="include"]
"20" -> "38" [dir=back tooltip="include"]
"20" -> "39" [dir=back tooltip="include"]
"20" -> "40" [dir=back tooltip="include"]
"20" -> "19" [dir=back tooltip="include"]
"20" -> "41" [dir=back tooltip="include"]
"20" -> "42" [dir=back tooltip="include"]
"20" -> "43" [dir=back tooltip="include"]
"20" -> "44" [dir=back tooltip="include"]
"20" -> "45" [dir=back tooltip="include"]
"20" -> "46" [dir=back tooltip="include"]
"20" -> "47" [dir=back tooltip="include"]
"20" -> "48" [dir=back tooltip="include"]
"20" -> "49" [dir=back tooltip="include"]
"20" -> "17" [dir=back tooltip="include"]
"20" -> "27" [dir=back tooltip="include"]
"20" -> "18" [dir=back tooltip="include"]
"20" -> "50" [dir=back tooltip="include"]
"20" -> "51" [dir=back tooltip="include"]
"12" -> "13" [dir=back tooltip="include"]
"13" -> "14" [dir=back tooltip="include"]
"24" -> "25" [dir=back tooltip="include"]
"24" -> "23" [dir=back tooltip="include"]
"35" -> "14" [dir=back tooltip="include"]
"14" -> "15" [dir=back tooltip="include"]
"14" -> "16" [dir=back tooltip="include"]
"48" -> "27" [dir=back tooltip="include"]
"48" -> "18" [dir=back tooltip="include"]
"26" -> "27" [dir=back tooltip="include"]
"37" -> "27" [dir=back tooltip="include"]
"37" -> "18" [dir=back tooltip="include"]
}](_images/graphviz-3c69cc4f9f679af3057fbfb948227470f8bdfd2f.png)
- 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"]
}](_images/graphviz-00b890c2d8b4dce0cc3a4a65b873c8db9d417e24.png)
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)
-
A1
- 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"]
}](_images/graphviz-f8ee241462fa3e0c916f378685b4ebb62dd109ae.png)
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"]
}](_images/graphviz-5825eeeb8e7b58d58ff2c802477b20cd21894303.png)
Typedefs
-
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)>
Functions
-
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 integrate_ode(Eigen::VectorXd&, double, double, double&, double, int, ode_derivs, ode_integrator)
-
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*)
-
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)
Variables
-
const double Pi = 3.141592653589793
-
using ode_integrator = std::function<void(Eigen::VectorXd&, Eigen::VectorXd&, int, double&, double, double, Eigen::VectorXd&, double&, double&, ode_derivs)>
- 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"]
}](_images/graphviz-4ffd911a7f0f5bc68a6dd179d81d5b3a15b37842.png)
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"]
"5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"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"]
"6" [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"]
"17" [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"]
"12" [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"]
"16" [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"]
"13" [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"]
"14" [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"]
"15" [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"]
"34" [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"]
"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"]
"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"]
"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"]
"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"]
"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"]
"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"]
"9" [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"]
"19" [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"]
"20" [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"]
"22" [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"]
"23" [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"]
"8" [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"]
"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"]
"21" [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"]
"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"]
"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"]
"24" [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"]
"10" [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"]
"11" [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"]
"18" [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"]
"25" [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"]
"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"]
"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"]
"4" -> "5" [dir=back tooltip="include"]
"6" -> "5" [dir=back tooltip="include"]
"6" -> "7" [dir=back tooltip="include"]
"6" -> "8" [dir=back tooltip="include"]
"6" -> "10" [dir=back tooltip="include"]
"17" -> "18" [dir=back tooltip="include"]
"12" -> "2" [dir=back tooltip="include"]
"16" -> "5" [dir=back tooltip="include"]
"16" -> "17" [dir=back tooltip="include"]
"16" -> "19" [dir=back tooltip="include"]
"16" -> "24" [dir=back tooltip="include"]
"16" -> "18" [dir=back tooltip="include"]
"16" -> "25" [dir=back tooltip="include"]
"2" -> "3" [dir=back tooltip="include"]
"15" -> "5" [dir=back tooltip="include"]
"15" -> "16" [dir=back tooltip="include"]
"15" -> "26" [dir=back tooltip="include"]
"15" -> "27" [dir=back tooltip="include"]
"15" -> "28" [dir=back tooltip="include"]
"15" -> "21" [dir=back tooltip="include"]
"15" -> "29" [dir=back tooltip="include"]
"15" -> "30" [dir=back tooltip="include"]
"31" -> "11" [dir=back tooltip="include"]
"31" -> "25" [dir=back tooltip="include"]
"33" -> "14" [dir=back tooltip="include"]
"3" -> "4" [dir=back tooltip="include"]
"3" -> "6" [dir=back tooltip="include"]
"3" -> "12" [dir=back tooltip="include"]
"3" -> "13" [dir=back tooltip="include"]
"3" -> "14" [dir=back tooltip="include"]
"3" -> "2" [dir=back tooltip="include"]
"3" -> "15" [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" -> "43" [dir=back tooltip="include"]
"3" -> "24" [dir=back tooltip="include"]
"3" -> "11" [dir=back tooltip="include"]
"3" -> "25" [dir=back tooltip="include"]
"3" -> "44" [dir=back tooltip="include"]
"3" -> "45" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"1" -> "3" [dir=back tooltip="include"]
"1" -> "41" [dir=back tooltip="include"]
"19" -> "20" [dir=back tooltip="include"]
"20" -> "21" [dir=back tooltip="include"]
"8" -> "9" [dir=back tooltip="include"]
"8" -> "7" [dir=back tooltip="include"]
"28" -> "21" [dir=back tooltip="include"]
"21" -> "22" [dir=back tooltip="include"]
"21" -> "23" [dir=back tooltip="include"]
"42" -> "11" [dir=back tooltip="include"]
"42" -> "25" [dir=back tooltip="include"]
"10" -> "11" [dir=back tooltip="include"]
"30" -> "11" [dir=back tooltip="include"]
"30" -> "25" [dir=back tooltip="include"]
}](_images/graphviz-3ee600808f75e4f45a3925cf8273603c247e9b8b.png)
- 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"]
}](_images/graphviz-0dac0ad6c326848fca8a276b1e7a00c3f8a215bc.png)
This graph shows which files directly or indirectly include OrthoFunction.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/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"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="/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"]
"2" -> "3" [dir=back tooltip="include"]
"2" -> "4" [dir=back tooltip="include"]
"2" -> "6" [dir=back tooltip="include"]
"2" -> "7" [dir=back tooltip="include"]
"4" -> "5" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"1" -> "4" [dir=back tooltip="include"]
"1" -> "7" [dir=back tooltip="include"]
}](_images/graphviz-ba24330c44bf53bcb49e4a673c238a0160551089.png)
- 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"]
}](_images/graphviz-90305eb98ca473437d7b6e8b09c260bbe0eaf8df.png)
- 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"]
}](_images/graphviz-25e3b60194744db23de49a24d539b04903bc756b.png)
- 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"]
}](_images/graphviz-2a03e9c2c2b75e193465145b3cf6c759f7d0e3d7.png)
- 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"]
}](_images/graphviz-00987846e459e5263af9b49086da35ff8eab2920.png)
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"]
"14" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"19" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Centering.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Centering.H"]
"15" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"17" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"18" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"20" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/ParticleIterator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/ParticleIterator.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"]
"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"]
"13" [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"]
"21" [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"]
"22" [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"]
"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"]
"23" [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"]
"34" [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"]
"35" [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"]
"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"]
"38" [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"]
"39" [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"]
"40" [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"]
"16" [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"]
"24" [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"]
"36" [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"]
"33" [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"]
"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"]
"32" [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"]
"25" [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"]
"26" [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"]
"27" [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"]
"28" [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"]
"29" [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"]
"30" [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"]
"31" [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"]
"37" [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"]
"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"]
"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"]
"14" -> "3" [dir=back tooltip="include"]
"14" -> "15" [dir=back tooltip="include"]
"14" -> "17" [dir=back tooltip="include"]
"14" -> "18" [dir=back tooltip="include"]
"15" -> "16" [dir=back tooltip="include"]
"4" -> "5" [dir=back tooltip="include"]
"2" -> "3" [dir=back tooltip="include"]
"2" -> "4" [dir=back tooltip="include"]
"2" -> "6" [dir=back tooltip="include"]
"2" -> "11" [dir=back tooltip="include"]
"2" -> "5" [dir=back tooltip="include"]
"2" -> "12" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"1" -> "13" [dir=back tooltip="include"]
"13" -> "14" [dir=back tooltip="include"]
"13" -> "3" [dir=back tooltip="include"]
"13" -> "19" [dir=back tooltip="include"]
"13" -> "15" [dir=back tooltip="include"]
"13" -> "18" [dir=back tooltip="include"]
"13" -> "20" [dir=back tooltip="include"]
"13" -> "21" [dir=back tooltip="include"]
"21" -> "22" [dir=back tooltip="include"]
"21" -> "34" [dir=back tooltip="include"]
"21" -> "38" [dir=back tooltip="include"]
"21" -> "39" [dir=back tooltip="include"]
"21" -> "40" [dir=back tooltip="include"]
"21" -> "16" [dir=back tooltip="include"]
"22" -> "23" [dir=back tooltip="include"]
"22" -> "32" [dir=back tooltip="include"]
"6" -> "7" [dir=back tooltip="include"]
"7" -> "8" [dir=back tooltip="include"]
"23" -> "24" [dir=back tooltip="include"]
"23" -> "25" [dir=back tooltip="include"]
"23" -> "26" [dir=back tooltip="include"]
"23" -> "27" [dir=back tooltip="include"]
"23" -> "28" [dir=back tooltip="include"]
"23" -> "29" [dir=back tooltip="include"]
"23" -> "30" [dir=back tooltip="include"]
"23" -> "31" [dir=back tooltip="include"]
"34" -> "23" [dir=back tooltip="include"]
"34" -> "35" [dir=back tooltip="include"]
"34" -> "36" [dir=back tooltip="include"]
"34" -> "32" [dir=back tooltip="include"]
"34" -> "37" [dir=back tooltip="include"]
"38" -> "38" [dir=back tooltip="include"]
"8" -> "9" [dir=back tooltip="include"]
"8" -> "10" [dir=back tooltip="include"]
"32" -> "6" [dir=back tooltip="include"]
"32" -> "33" [dir=back tooltip="include"]
}](_images/graphviz-94e4debec61b3bfd30b6201fdf1c556827098a17.png)
Typedefs
- 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"]
}](_images/graphviz-b5b95ba3564d83378301da4137cee5fdfc2b8aa2.png)
This graph shows which files directly or indirectly include ParticleReader.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/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Centering.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Centering.H"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/ParticleIterator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/ParticleIterator.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"]
"10" [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"]
"11" [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"]
"22" [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"]
"25" [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/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
"28" [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"]
"29" [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"]
"26" [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"]
"32" [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"]
"33" [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"]
"34" [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/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
"13" [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"]
"30" [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"]
"27" [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"]
"24" [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"]
"21" [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"]
"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"]
"20" [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"]
"31" [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" -> "4" [dir=back tooltip="include"]
"2" -> "6" [dir=back tooltip="include"]
"2" -> "7" [dir=back tooltip="include"]
"4" -> "5" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"1" -> "3" [dir=back tooltip="include"]
"1" -> "8" [dir=back tooltip="include"]
"1" -> "4" [dir=back tooltip="include"]
"1" -> "7" [dir=back tooltip="include"]
"1" -> "9" [dir=back tooltip="include"]
"1" -> "10" [dir=back tooltip="include"]
"10" -> "11" [dir=back tooltip="include"]
"10" -> "28" [dir=back tooltip="include"]
"10" -> "32" [dir=back tooltip="include"]
"10" -> "33" [dir=back tooltip="include"]
"10" -> "34" [dir=back tooltip="include"]
"10" -> "5" [dir=back tooltip="include"]
"11" -> "12" [dir=back tooltip="include"]
"11" -> "21" [dir=back tooltip="include"]
"22" -> "23" [dir=back tooltip="include"]
"23" -> "24" [dir=back tooltip="include"]
"12" -> "13" [dir=back tooltip="include"]
"12" -> "14" [dir=back tooltip="include"]
"12" -> "15" [dir=back tooltip="include"]
"12" -> "16" [dir=back tooltip="include"]
"12" -> "17" [dir=back tooltip="include"]
"12" -> "18" [dir=back tooltip="include"]
"12" -> "19" [dir=back tooltip="include"]
"12" -> "20" [dir=back tooltip="include"]
"28" -> "12" [dir=back tooltip="include"]
"28" -> "29" [dir=back tooltip="include"]
"28" -> "30" [dir=back tooltip="include"]
"28" -> "21" [dir=back tooltip="include"]
"28" -> "31" [dir=back tooltip="include"]
"32" -> "32" [dir=back tooltip="include"]
"24" -> "25" [dir=back tooltip="include"]
"24" -> "26" [dir=back tooltip="include"]
"21" -> "22" [dir=back tooltip="include"]
"21" -> "27" [dir=back tooltip="include"]
}](_images/graphviz-8eb50a6f2790f794b21c441587fa96b5a41aa3ff.png)
- 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"]
}](_images/graphviz-d58b5bfaedd259c8e1285753a42ed2b032a6b855.png)
- 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"]
}](_images/graphviz-418565142b96c56e5816730ed8ddb648bbd68e94.png)
Typedefs
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)
-
double Oort_A(double)
-
double Oort_B(double)
-
double v_circ(double)
-
double vertical_kappa(double)
-
double epicyclic_kappa(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"]
}](_images/graphviz-2a1399e2d446888f303376a883344b2a9b805728.png)
- 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"]
}](_images/graphviz-b35be346033b8fcb7ce8e895ecca3ef6aa5b7914.png)
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"]
}](_images/graphviz-4f66ac8200cbf4de2730ae5c8ed4bc14ad133a84.png)
- 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"]
}](_images/graphviz-4beabce3fea60e82956b29c9554769ae58a320b8.png)
- 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"]
}](_images/graphviz-4ec82f93ce87bcfa0707a456fc2ebd661cd8cfc7.png)
- 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"]
}](_images/graphviz-b83f397c7f64b3341928190b774b92e5da7e4760.png)
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"]
"2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"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"]
"9" [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"]
"10" [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"]
"21" [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"]
"24" [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"]
"11" [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"]
"27" [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"]
"28" [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"]
"25" [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"]
"8" [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"]
"31" [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"]
"32" [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"]
"33" [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/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
"12" [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"]
"29" [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"]
"26" [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"]
"23" [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"]
"20" [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"]
"13" [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"]
"14" [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"]
"15" [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"]
"16" [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"]
"17" [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"]
"18" [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"]
"19" [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"]
"30" [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" -> "4" [dir=back tooltip="include"]
"2" -> "6" [dir=back tooltip="include"]
"2" -> "7" [dir=back tooltip="include"]
"4" -> "5" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"1" -> "8" [dir=back tooltip="include"]
"9" -> "10" [dir=back tooltip="include"]
"9" -> "27" [dir=back tooltip="include"]
"9" -> "31" [dir=back tooltip="include"]
"9" -> "32" [dir=back tooltip="include"]
"9" -> "33" [dir=back tooltip="include"]
"9" -> "5" [dir=back tooltip="include"]
"10" -> "11" [dir=back tooltip="include"]
"10" -> "20" [dir=back tooltip="include"]
"21" -> "22" [dir=back tooltip="include"]
"22" -> "23" [dir=back tooltip="include"]
"11" -> "12" [dir=back tooltip="include"]
"11" -> "13" [dir=back tooltip="include"]
"11" -> "14" [dir=back tooltip="include"]
"11" -> "15" [dir=back tooltip="include"]
"11" -> "16" [dir=back tooltip="include"]
"11" -> "17" [dir=back tooltip="include"]
"11" -> "18" [dir=back tooltip="include"]
"11" -> "19" [dir=back tooltip="include"]
"27" -> "11" [dir=back tooltip="include"]
"27" -> "28" [dir=back tooltip="include"]
"27" -> "29" [dir=back tooltip="include"]
"27" -> "20" [dir=back tooltip="include"]
"27" -> "30" [dir=back tooltip="include"]
"8" -> "9" [dir=back tooltip="include"]
"8" -> "22" [dir=back tooltip="include"]
"31" -> "31" [dir=back tooltip="include"]
"23" -> "24" [dir=back tooltip="include"]
"23" -> "25" [dir=back tooltip="include"]
"20" -> "21" [dir=back tooltip="include"]
"20" -> "26" [dir=back tooltip="include"]
}](_images/graphviz-953a0efa252209e22fb8a44852b3a42f501a0b87.png)
- 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"]
}](_images/graphviz-6d73a459a08aba54311404bfcecc068792b10c26.png)
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"]
}](_images/graphviz-c6c58bd82a1a2aa302a99b3d024c0e6d44c9f7bd.png)
- 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"]
}](_images/graphviz-819d72f5acf55ebdfff1c1f9900abfb152b43b10.png)
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"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"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"]
"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"]
"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"]
"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"]
"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"]
"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"]
"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"]
"3" -> "4" [dir=back tooltip="include"]
"5" -> "4" [dir=back tooltip="include"]
"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" -> "1" [dir=back tooltip="include"]
"15" -> "4" [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"]
"1" -> "2" [dir=back tooltip="include"]
"14" -> "4" [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"]
"2" -> "3" [dir=back tooltip="include"]
"2" -> "5" [dir=back tooltip="include"]
"2" -> "11" [dir=back tooltip="include"]
"2" -> "12" [dir=back tooltip="include"]
"2" -> "13" [dir=back tooltip="include"]
"2" -> "1" [dir=back tooltip="include"]
"2" -> "14" [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" -> "42" [dir=back tooltip="include"]
"2" -> "23" [dir=back tooltip="include"]
"2" -> "10" [dir=back tooltip="include"]
"2" -> "24" [dir=back tooltip="include"]
"2" -> "43" [dir=back tooltip="include"]
"2" -> "44" [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"]
}](_images/graphviz-4b1ff83e9e7bcb7850d12c8b77f9524fb392acbe.png)
- 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"]
}](_images/graphviz-a18d6ba82f49b095feda174366c58086924ebfa3.png)
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"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"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"]
"10" [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"]
"11" [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"]
"22" [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"]
"25" [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/ExternalCollection.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/ExternalCollection.H"]
"28" [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"]
"29" [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"]
"26" [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"]
"9" [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"]
"32" [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"]
"33" [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"]
"34" [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"]
"6" [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"]
"13" [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"]
"30" [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"]
"27" [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"]
"24" [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"]
"21" [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"]
"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"]
"20" [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"]
"31" [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" -> "7" [dir=back tooltip="include"]
"3" -> "8" [dir=back tooltip="include"]
"5" -> "6" [dir=back tooltip="include"]
"2" -> "3" [dir=back tooltip="include"]
"2" -> "9" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"10" -> "11" [dir=back tooltip="include"]
"10" -> "28" [dir=back tooltip="include"]
"10" -> "32" [dir=back tooltip="include"]
"10" -> "33" [dir=back tooltip="include"]
"10" -> "34" [dir=back tooltip="include"]
"10" -> "6" [dir=back tooltip="include"]
"11" -> "12" [dir=back tooltip="include"]
"11" -> "21" [dir=back tooltip="include"]
"22" -> "23" [dir=back tooltip="include"]
"23" -> "24" [dir=back tooltip="include"]
"12" -> "13" [dir=back tooltip="include"]
"12" -> "14" [dir=back tooltip="include"]
"12" -> "15" [dir=back tooltip="include"]
"12" -> "16" [dir=back tooltip="include"]
"12" -> "17" [dir=back tooltip="include"]
"12" -> "18" [dir=back tooltip="include"]
"12" -> "19" [dir=back tooltip="include"]
"12" -> "20" [dir=back tooltip="include"]
"28" -> "12" [dir=back tooltip="include"]
"28" -> "29" [dir=back tooltip="include"]
"28" -> "30" [dir=back tooltip="include"]
"28" -> "21" [dir=back tooltip="include"]
"28" -> "31" [dir=back tooltip="include"]
"9" -> "10" [dir=back tooltip="include"]
"9" -> "23" [dir=back tooltip="include"]
"32" -> "32" [dir=back tooltip="include"]
"24" -> "25" [dir=back tooltip="include"]
"24" -> "26" [dir=back tooltip="include"]
"21" -> "22" [dir=back tooltip="include"]
"21" -> "27" [dir=back tooltip="include"]
}](_images/graphviz-cf2e875048d2d4b8ae599b8061bc10e8bf639735.png)
- 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"]
}](_images/graphviz-51f17aaf211bb3858975c0440ac4f02273ccb5b6.png)
- 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)
-
double epicyclic_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"]
}](_images/graphviz-6135b9024d4aa1a6c2979f3332c0b0ac0ea1cb92.png)
- 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"]
}](_images/graphviz-1c8b251cb6dac690e58caee6d176b3a4c13d304e.png)
Defines
-
SIM_ANN_HPP_
-
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"]
}](_images/graphviz-0570d631506ecb5555ca052f44a366e31c79532d.png)
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"]
"2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.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"]
"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"]
"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"]
"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" -> "2" [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"]
"1" -> "3" [dir=back tooltip="include"]
"1" -> "13" [dir=back tooltip="include"]
"1" -> "14" [dir=back tooltip="include"]
"1" -> "15" [dir=back tooltip="include"]
"1" -> "8" [dir=back tooltip="include"]
"1" -> "16" [dir=back tooltip="include"]
"1" -> "17" [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"]
}](_images/graphviz-117a8bd57798364a99125635ffad959c590ee831.png)
- 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"]
}](_images/graphviz-e556cf671a7ab4671da00aa597fbd89c1cab1cf2.png)
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"]
"2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"5" [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"]
"4" [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"]
"3" [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"]
"14" [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"]
"7" [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"]
"8" [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"]
"10" [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"]
"11" [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"]
"15" [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"]
"9" [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"]
"17" [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"]
"12" [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/Disk2dHalo.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/ICs/Disk2dHalo.H"]
"6" [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"]
"13" [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"]
"18" [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"]
"5" -> "6" [dir=back tooltip="include"]
"4" -> "2" [dir=back tooltip="include"]
"4" -> "5" [dir=back tooltip="include"]
"4" -> "7" [dir=back tooltip="include"]
"4" -> "12" [dir=back tooltip="include"]
"4" -> "6" [dir=back tooltip="include"]
"4" -> "13" [dir=back tooltip="include"]
"3" -> "2" [dir=back tooltip="include"]
"3" -> "4" [dir=back tooltip="include"]
"3" -> "14" [dir=back tooltip="include"]
"3" -> "15" [dir=back tooltip="include"]
"3" -> "16" [dir=back tooltip="include"]
"3" -> "9" [dir=back tooltip="include"]
"3" -> "17" [dir=back tooltip="include"]
"3" -> "18" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"1" -> "3" [dir=back tooltip="include"]
"7" -> "8" [dir=back tooltip="include"]
"8" -> "9" [dir=back tooltip="include"]
"16" -> "9" [dir=back tooltip="include"]
"9" -> "10" [dir=back tooltip="include"]
"9" -> "11" [dir=back tooltip="include"]
"18" -> "19" [dir=back tooltip="include"]
"18" -> "13" [dir=back tooltip="include"]
}](_images/graphviz-0cf3b0d2848b15bd704d5c249a072f0f19712ec4.png)
- 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"]
}](_images/graphviz-227980aff1ae040d9aba4e0cb00f1dfe8cfc1223.png)
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"]
}](_images/graphviz-05e2e8122f7a0d2473d0d20b39df5decadc1fe4c.png)
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::map<speciesKey, sKeyDmap> sKey2Dmap
- 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"]
}](_images/graphviz-dd7805503beb331f660d6a81de13b55e67fe74cf.png)
- 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"]
}](_images/graphviz-79da63bf3bf021b684f6636f1625a055f0bdf0b5.png)
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>
- 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"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Centering.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Centering.H"]
"5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/ParticleIterator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/ParticleIterator.H"]
"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"]
"42" [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"]
"41" [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"]
"48" [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"]
"45" [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"]
"11" [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"]
"12" [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"]
"50" [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"]
"23" [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"]
"24" [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"]
"43" [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"]
"26" [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"]
"13" [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"]
"46" [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"]
"27" [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"]
"51" [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"]
"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"]
"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"]
"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"]
"6" [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"]
"14" [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"]
"44" [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/PotAccel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PotAccel.H"]
"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"]
"28" [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"]
"52" [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"]
"49" [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"]
"47" [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"]
"25" [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"]
"22" [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"]
"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"]
"21" [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"]
"53" [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"]
"54" [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"]
"3" -> "8" [dir=back tooltip="include"]
"5" -> "6" [dir=back tooltip="include"]
"2" -> "3" [dir=back tooltip="include"]
"2" -> "4" [dir=back tooltip="include"]
"2" -> "9" [dir=back tooltip="include"]
"2" -> "5" [dir=back tooltip="include"]
"2" -> "8" [dir=back tooltip="include"]
"2" -> "10" [dir=back tooltip="include"]
"2" -> "11" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"1" -> "36" [dir=back tooltip="include"]
"1" -> "40" [dir=back tooltip="include"]
"1" -> "53" [dir=back tooltip="include"]
"1" -> "54" [dir=back tooltip="include"]
"42" -> "43" [dir=back tooltip="include"]
"42" -> "14" [dir=back tooltip="include"]
"42" -> "44" [dir=back tooltip="include"]
"42" -> "28" [dir=back tooltip="include"]
"42" -> "47" [dir=back tooltip="include"]
"42" -> "15" [dir=back tooltip="include"]
"42" -> "16" [dir=back tooltip="include"]
"42" -> "17" [dir=back tooltip="include"]
"42" -> "18" [dir=back tooltip="include"]
"42" -> "19" [dir=back tooltip="include"]
"42" -> "20" [dir=back tooltip="include"]
"41" -> "42" [dir=back tooltip="include"]
"41" -> "24" [dir=back tooltip="include"]
"48" -> "25" [dir=back tooltip="include"]
"11" -> "12" [dir=back tooltip="include"]
"11" -> "29" [dir=back tooltip="include"]
"11" -> "33" [dir=back tooltip="include"]
"11" -> "34" [dir=back tooltip="include"]
"11" -> "35" [dir=back tooltip="include"]
"11" -> "6" [dir=back tooltip="include"]
"12" -> "13" [dir=back tooltip="include"]
"12" -> "22" [dir=back tooltip="include"]
"23" -> "24" [dir=back tooltip="include"]
"24" -> "25" [dir=back tooltip="include"]
"13" -> "14" [dir=back tooltip="include"]
"13" -> "15" [dir=back tooltip="include"]
"13" -> "16" [dir=back tooltip="include"]
"13" -> "17" [dir=back tooltip="include"]
"13" -> "18" [dir=back tooltip="include"]
"13" -> "19" [dir=back tooltip="include"]
"13" -> "20" [dir=back tooltip="include"]
"13" -> "21" [dir=back tooltip="include"]
"29" -> "13" [dir=back tooltip="include"]
"29" -> "30" [dir=back tooltip="include"]
"29" -> "31" [dir=back tooltip="include"]
"29" -> "22" [dir=back tooltip="include"]
"29" -> "32" [dir=back tooltip="include"]
"33" -> "33" [dir=back tooltip="include"]
"36" -> "37" [dir=back tooltip="include"]
"36" -> "34" [dir=back tooltip="include"]
"36" -> "35" [dir=back tooltip="include"]
"36" -> "38" [dir=back tooltip="include"]
"36" -> "39" [dir=back tooltip="include"]
"36" -> "22" [dir=back tooltip="include"]
"44" -> "45" [dir=back tooltip="include"]
"44" -> "46" [dir=back tooltip="include"]
"40" -> "41" [dir=back tooltip="include"]
"40" -> "11" [dir=back tooltip="include"]
"40" -> "50" [dir=back tooltip="include"]
"40" -> "29" [dir=back tooltip="include"]
"40" -> "51" [dir=back tooltip="include"]
"40" -> "52" [dir=back tooltip="include"]
"49" -> "25" [dir=back tooltip="include"]
"47" -> "48" [dir=back tooltip="include"]
"47" -> "49" [dir=back tooltip="include"]
"25" -> "26" [dir=back tooltip="include"]
"25" -> "27" [dir=back tooltip="include"]
"22" -> "23" [dir=back tooltip="include"]
"22" -> "28" [dir=back tooltip="include"]
}](_images/graphviz-4c6d5c907efa49cadc3918e895810cee5891396a.png)
- 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"]
}](_images/graphviz-cd8379006cfeb8587432134df6401fa1819dab05.png)
- 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"]
}](_images/graphviz-9d815131c64759e83d3f3c23b04d98f16cbf4c42.png)
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"]
}](_images/graphviz-c69268c55fbcb6b918a5a5b9d499d95a8dcb0e81.png)
- 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"]
}](_images/graphviz-2c3fce81efee8fc00471eaed615714a605a4f46a.png)
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
-
std::filesystem::path temp_file(const std::string &prefix, std::size_t length = 16)
- 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"]
}](_images/graphviz-bf74e40c9f8c8beba11e9c8c5569b51061f790a1.png)
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"]
}](_images/graphviz-6bbd016383527d1bd76eae897b921d4c960cc1aa.png)
Typedefs
-
typedef std::shared_ptr<ThreeDGrid> ThreeDGridPtr
-
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"]
}](_images/graphviz-444a2aed2eeb18bd86d92036ae5d71620d37e0dd.png)
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"]
"31" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"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"]
"32" [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"]
"36" [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"]
"38" [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"]
"39" [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"]
"37" [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"]
"40" [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"]
"34" [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"]
"33" [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"]
"35" [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"]
"32" -> "33" [dir=back tooltip="include"]
"30" -> "31" [dir=back tooltip="include"]
"30" -> "32" [dir=back tooltip="include"]
"30" -> "16" [dir=back tooltip="include"]
"30" -> "34" [dir=back tooltip="include"]
"30" -> "33" [dir=back tooltip="include"]
"30" -> "35" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"1" -> "30" [dir=back tooltip="include"]
"1" -> "36" [dir=back tooltip="include"]
"1" -> "4" [dir=back tooltip="include"]
"1" -> "5" [dir=back tooltip="include"]
"1" -> "37" [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"]
"37" -> "38" [dir=back tooltip="include"]
"37" -> "27" [dir=back tooltip="include"]
"37" -> "28" [dir=back tooltip="include"]
"37" -> "39" [dir=back tooltip="include"]
"37" -> "40" [dir=back tooltip="include"]
"37" -> "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"]
}](_images/graphviz-97d7c067018b64071eb96a08d152283c6bddf977.png)
- 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"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"9" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Centering.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/Centering.H"]
"5" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"8" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"10" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/ParticleIterator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/ParticleIterator.H"]
"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"]
"11" [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"]
"12" [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"]
"23" [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"]
"24" [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"]
"26" [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"]
"13" [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"]
"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"]
"27" [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"]
"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"]
"6" [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"]
"14" [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"]
"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"]
"28" [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/TwoCenter.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/TwoCenter.H"]
"22" [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"]
"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"]
"21" [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" -> "7" [dir=back tooltip="include"]
"3" -> "8" [dir=back tooltip="include"]
"5" -> "6" [dir=back tooltip="include"]
"2" -> "3" [dir=back tooltip="include"]
"2" -> "4" [dir=back tooltip="include"]
"2" -> "9" [dir=back tooltip="include"]
"2" -> "5" [dir=back tooltip="include"]
"2" -> "8" [dir=back tooltip="include"]
"2" -> "10" [dir=back tooltip="include"]
"2" -> "11" [dir=back tooltip="include"]
"1" -> "2" [dir=back tooltip="include"]
"11" -> "12" [dir=back tooltip="include"]
"11" -> "29" [dir=back tooltip="include"]
"11" -> "33" [dir=back tooltip="include"]
"11" -> "34" [dir=back tooltip="include"]
"11" -> "35" [dir=back tooltip="include"]
"11" -> "6" [dir=back tooltip="include"]
"12" -> "13" [dir=back tooltip="include"]
"12" -> "22" [dir=back tooltip="include"]
"23" -> "24" [dir=back tooltip="include"]
"24" -> "25" [dir=back tooltip="include"]
"13" -> "14" [dir=back tooltip="include"]
"13" -> "15" [dir=back tooltip="include"]
"13" -> "16" [dir=back tooltip="include"]
"13" -> "17" [dir=back tooltip="include"]
"13" -> "18" [dir=back tooltip="include"]
"13" -> "19" [dir=back tooltip="include"]
"13" -> "20" [dir=back tooltip="include"]
"13" -> "21" [dir=back tooltip="include"]
"29" -> "13" [dir=back tooltip="include"]
"29" -> "30" [dir=back tooltip="include"]
"29" -> "31" [dir=back tooltip="include"]
"29" -> "22" [dir=back tooltip="include"]
"29" -> "32" [dir=back tooltip="include"]
"33" -> "33" [dir=back tooltip="include"]
"25" -> "26" [dir=back tooltip="include"]
"25" -> "27" [dir=back tooltip="include"]
"22" -> "23" [dir=back tooltip="include"]
"22" -> "28" [dir=back tooltip="include"]
}](_images/graphviz-812fefdada118ac3666f9e5b2aee0fa6cb00f5ca.png)
- 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"]
}](_images/graphviz-169b61b0b533cd93ea7583e1ff92edeaf3716e97.png)
- 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"]
}](_images/graphviz-7c18919e2ce8e3879bae594c880d4bdc903d63ea.png)
- 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"]
}](_images/graphviz-39c960a624347816ad75587025f8d736a8a6ead2.png)
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"]
}](_images/graphviz-98fed1ee08d4bbf34d91d2fd78895edb907cc7b6.png)
- 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"]
}](_images/graphviz-fe3079088f620fdeb2e000857bc7cef0378f83db.png)
- 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"]
}](_images/graphviz-e077f3b584a151448ee5ea2640b1adb83d95176f.png)
- 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"]
}](_images/graphviz-8c030641c1ffd306043a112bacfb12887015a565.png)
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"]
"2" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BasisFactory.H"]
"3" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/BiorthBasis.H"]
"4" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldBasis.H"]
"6" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/FieldGenerator.H"]
"7" [label="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/expui/OrthoBasisFactory.H"]
"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"]
"10" [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"]
"9" [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"]
"18" [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"]
"14" [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"]
"30" [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"]
"31" [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"]
"35" [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"]
"29" [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/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"]
"32" [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"]
"36" [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"]
"15" [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"]
"37" [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"]
"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"]
"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"]
"40" [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"]
"41" [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"]
"42" [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/OutVel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/OutVel.H"]
"12" [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"]
"13" [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/PotAccel.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/PotAccel.H"]
"38" [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"]
"16" [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"]
"22" [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/SphericalBasis.H" tooltip="/home/runner/work/EXP-docs/EXP-docs/exp_repo/src/SphericalBasis.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"]
"34" [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"]
"23" [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"]
"24" [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"]
"25" [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"]
"26" [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"]
"27" [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"]
"28" [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"]
"33" [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"]
"39" [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" -> "4" [dir=back tooltip="include"]
"2" -> "6" [dir=back tooltip="include"]
"2" -> "7" [dir=back tooltip="include"]
"4" -> "5" [dir=back tooltip="include"]
"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"]
"10" -> "11" [dir=back tooltip="include"]
"10" -> "12" [dir=back tooltip="include"]
"10" -> "13" [dir=back tooltip="include"]
"10" -> "16" [dir=back tooltip="include"]
"10" -> "17" [dir=back tooltip="include"]
"10" -> "23" [dir=back tooltip="include"]
"10" -> "24" [dir=back tooltip="include"]
"10" -> "25" [dir=back tooltip="include"]
"10" -> "26" [dir=back tooltip="include"]
"10" -> "27" [dir=back tooltip="include"]
"10" -> "28" [dir=back tooltip="include"]
"9" -> "10" [dir=back tooltip="include"]
"9" -> "29" [dir=back tooltip="include"]
"18" -> "19" [dir=back tooltip="include"]
"30" -> "31" [dir=back tooltip="include"]
"30" -> "36" [dir=back tooltip="include"]
"30" -> "40" [dir=back tooltip="include"]
"30" -> "41" [dir=back tooltip="include"]
"30" -> "42" [dir=back tooltip="include"]
"30" -> "5" [dir=back tooltip="include"]
"31" -> "32" [dir=back tooltip="include"]
"31" -> "34" [dir=back tooltip="include"]
"35" -> "29" [dir=back tooltip="include"]
"29" -> "19" [dir=back tooltip="include"]
"32" -> "12" [dir=back tooltip="include"]
"32" -> "23" [dir=back tooltip="include"]
"32" -> "24" [dir=back tooltip="include"]
"32" -> "25" [dir=back tooltip="include"]
"32" -> "26" [dir=back tooltip="include"]
"32" -> "27" [dir=back tooltip="include"]
"32" -> "28" [dir=back tooltip="include"]
"32" -> "33" [dir=back tooltip="include"]
"36" -> "32" [dir=back tooltip="include"]
"36" -> "37" [dir=back tooltip="include"]
"36" -> "38" [dir=back tooltip="include"]
"36" -> "34" [dir=back tooltip="include"]
"36" -> "39" [dir=back tooltip="include"]
"40" -> "40" [dir=back tooltip="include"]
"13" -> "14" [dir=back tooltip="include"]
"13" -> "15" [dir=back tooltip="include"]
"8" -> "9" [dir=back tooltip="include"]
"8" -> "30" [dir=back tooltip="include"]
"8" -> "43" [dir=back tooltip="include"]
"8" -> "36" [dir=back tooltip="include"]
"8" -> "44" [dir=back tooltip="include"]
"8" -> "45" [dir=back tooltip="include"]
"22" -> "19" [dir=back tooltip="include"]
"17" -> "18" [dir=back tooltip="include"]
"17" -> "22" [dir=back tooltip="include"]
"19" -> "20" [dir=back tooltip="include"]
"19" -> "21" [dir=back tooltip="include"]
"34" -> "35" [dir=back tooltip="include"]
"34" -> "16" [dir=back tooltip="include"]
}](_images/graphviz-4387edd26db7143067648381d583b6b3aa94cb6a.png)
- 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"]
}](_images/graphviz-a3a2009107ae7b265644e0594245cebbe9b004f6.png)
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.
-
cxxopts::ParseResult LoadConfig(cxxopts::Options &options, const std::string &config)
- 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"]
}](_images/graphviz-e0c43a9041d61cc9ab305de235987c98d0eecc5c.png)
- 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"]
}](_images/graphviz-7964045694af1d83ca6941c103bbf12b73fefe67.png)
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"]
}](_images/graphviz-35c0c2898f0cc5b20f24a75e18ab3d163ca50a19.png)
- 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"]
}](_images/graphviz-fc8272d23c3e16c8363216e7d9cd3094f74bb47f.png)
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"]
}](_images/graphviz-409438fce84a9493334a2e963a4a38c1a48dfbd6.png)
- 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"]
"29" [label="CoefContainer.H" tooltip="CoefContainer.H"]
"27" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"22" [label="Coefficients.H" tooltip="Coefficients.H"]
"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"]
"28" [label="NVTX.H" tooltip="NVTX.H"]
"11" [label="PotAccel.H" tooltip="PotAccel.H"]
"3" [label="SphericalBasis.H" tooltip="SphericalBasis.H"]
"30" [label="Eigen/Dense" tooltip="Eigen/Dense"]
"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"]
"25" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"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"]
"24" [label="stdexcept" tooltip="stdexcept"]
"7" [label="string" tooltip="string"]
"23" [label="tuple" tooltip="tuple"]
"26" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"6" [label="vector" tooltip="vector"]
"16" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"29" -> "4" [dir=forward tooltip="include"]
"29" -> "23" [dir=forward tooltip="include"]
"29" -> "15" [dir=forward tooltip="include"]
"29" -> "8" [dir=forward tooltip="include"]
"29" -> "30" [dir=forward tooltip="include"]
"29" -> "22" [dir=forward tooltip="include"]
"27" -> "4" [dir=forward tooltip="include"]
"27" -> "21" [dir=forward tooltip="include"]
"27" -> "26" [dir=forward tooltip="include"]
"22" -> "23" [dir=forward tooltip="include"]
"22" -> "24" [dir=forward tooltip="include"]
"22" -> "25" [dir=forward tooltip="include"]
"22" -> "21" [dir=forward tooltip="include"]
"22" -> "26" [dir=forward tooltip="include"]
"22" -> "16" [dir=forward tooltip="include"]
"22" -> "27" [dir=forward tooltip="include"]
"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"]
"28" -> "4" [dir=forward tooltip="include"]
"28" -> "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" -> "28" [dir=forward tooltip="include"]
"3" -> "29" [dir=forward tooltip="include"]
}](_images/graphviz-922cf97689286fd83d7dd94e7c032fbf4b7e8eb9.png)
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"]
}](_images/graphviz-06bfa257a562b06b05126289213ed1a56d9599ce.png)
Functions
-
Eigen::VectorXd sbessjz(int n, int m)
-
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"]
}](_images/graphviz-12290c5bd7338bfed6f8100cde6142ed3e9f8ced.png)
- 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"]
"28" [label="CoefContainer.H" tooltip="CoefContainer.H"]
"26" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"21" [label="Coefficients.H" tooltip="Coefficients.H"]
"30" [label="BiorthCyl.H" tooltip="BiorthCyl.H"]
"46" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
"54" [label="EXPmath.H" tooltip="EXPmath.H"]
"50" [label="EmpCyl2d.H" tooltip="EmpCyl2d.H"]
"40" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
"45" [label="QPDistF.H" tooltip="QPDistF.H"]
"17" [label="StringTok.H" tooltip="StringTok.H"]
"18" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"43" [label="gaussQ.H" tooltip="gaussQ.H"]
"38" [label="interp.H" tooltip="interp.H"]
"35" [label="localmpi.H" tooltip="localmpi.H"]
"37" [label="massmodel.H" tooltip="massmodel.H"]
"41" [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"]
"27" [label="NVTX.H" tooltip="NVTX.H"]
"4" [label="PolarBasis.H" tooltip="PolarBasis.H"]
"11" [label="PotAccel.H" tooltip="PotAccel.H"]
"29" [label="Eigen/Dense" tooltip="Eigen/Dense"]
"20" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"53" [label="Eigen/Eigenvalues" tooltip="Eigen/Eigenvalues"]
"16" [label="Particle.H" tooltip="Particle.H"]
"51" [label="algorithm" tooltip="algorithm"]
"52" [label="array" tooltip="array"]
"13" [label="chrono" tooltip="chrono"]
"33" [label="cmath" tooltip="cmath"]
"19" [label="config_exp.h" tooltip="config_exp.h"]
"12" [label="cstdlib" tooltip="cstdlib"]
"39" [label="deque" tooltip="deque"]
"32" [label="fstream" tooltip="fstream"]
"42" [label="functional" tooltip="functional"]
"49" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"47" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"48" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"24" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"56" [label="highfive/eigen.hpp" tooltip="highfive/eigen.hpp"]
"55" [label="highfive/highfive.hpp" tooltip="highfive/highfive.hpp"]
"36" [label="iomanip" tooltip="iomanip"]
"31" [label="iostream" tooltip="iostream"]
"14" [label="list" tooltip="list"]
"3" [label="map" tooltip="map"]
"2" [label="memory" tooltip="memory"]
"34" [label="mpi.h" tooltip="mpi.h"]
"5" [label="random" tooltip="random"]
"8" [label="set" tooltip="set"]
"44" [label="sstream" tooltip="sstream"]
"23" [label="stdexcept" tooltip="stdexcept"]
"7" [label="string" tooltip="string"]
"22" [label="tuple" tooltip="tuple"]
"25" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"6" [label="vector" tooltip="vector"]
"15" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"28" -> "2" [dir=forward tooltip="include"]
"28" -> "22" [dir=forward tooltip="include"]
"28" -> "3" [dir=forward tooltip="include"]
"28" -> "8" [dir=forward tooltip="include"]
"28" -> "29" [dir=forward tooltip="include"]
"28" -> "21" [dir=forward tooltip="include"]
"26" -> "2" [dir=forward tooltip="include"]
"26" -> "20" [dir=forward tooltip="include"]
"26" -> "25" [dir=forward tooltip="include"]
"21" -> "22" [dir=forward tooltip="include"]
"21" -> "23" [dir=forward tooltip="include"]
"21" -> "24" [dir=forward tooltip="include"]
"21" -> "20" [dir=forward tooltip="include"]
"21" -> "25" [dir=forward tooltip="include"]
"21" -> "15" [dir=forward tooltip="include"]
"21" -> "26" [dir=forward tooltip="include"]
"30" -> "31" [dir=forward tooltip="include"]
"30" -> "32" [dir=forward tooltip="include"]
"30" -> "7" [dir=forward tooltip="include"]
"30" -> "33" [dir=forward tooltip="include"]
"30" -> "20" [dir=forward tooltip="include"]
"30" -> "34" [dir=forward tooltip="include"]
"30" -> "35" [dir=forward tooltip="include"]
"30" -> "19" [dir=forward tooltip="include"]
"30" -> "37" [dir=forward tooltip="include"]
"30" -> "15" [dir=forward tooltip="include"]
"30" -> "24" [dir=forward tooltip="include"]
"30" -> "47" [dir=forward tooltip="include"]
"30" -> "48" [dir=forward tooltip="include"]
"30" -> "49" [dir=forward tooltip="include"]
"30" -> "50" [dir=forward tooltip="include"]
"46" -> "37" [dir=forward tooltip="include"]
"50" -> "51" [dir=forward tooltip="include"]
"50" -> "2" [dir=forward tooltip="include"]
"50" -> "7" [dir=forward tooltip="include"]
"50" -> "6" [dir=forward tooltip="include"]
"50" -> "52" [dir=forward tooltip="include"]
"50" -> "22" [dir=forward tooltip="include"]
"50" -> "20" [dir=forward tooltip="include"]
"50" -> "53" [dir=forward tooltip="include"]
"50" -> "15" [dir=forward tooltip="include"]
"50" -> "19" [dir=forward tooltip="include"]
"50" -> "43" [dir=forward tooltip="include"]
"50" -> "54" [dir=forward tooltip="include"]
"50" -> "35" [dir=forward tooltip="include"]
"50" -> "55" [dir=forward tooltip="include"]
"50" -> "56" [dir=forward tooltip="include"]
"40" -> "6" [dir=forward tooltip="include"]
"40" -> "3" [dir=forward tooltip="include"]
"40" -> "7" [dir=forward tooltip="include"]
"45" -> "36" [dir=forward tooltip="include"]
"45" -> "7" [dir=forward tooltip="include"]
"45" -> "3" [dir=forward tooltip="include"]
"45" -> "37" [dir=forward tooltip="include"]
"45" -> "46" [dir=forward tooltip="include"]
"45" -> "41" [dir=forward tooltip="include"]
"18" -> "7" [dir=forward tooltip="include"]
"18" -> "8" [dir=forward tooltip="include"]
"18" -> "15" [dir=forward tooltip="include"]
"43" -> "31" [dir=forward tooltip="include"]
"43" -> "36" [dir=forward tooltip="include"]
"43" -> "44" [dir=forward tooltip="include"]
"43" -> "12" [dir=forward tooltip="include"]
"43" -> "7" [dir=forward tooltip="include"]
"43" -> "6" [dir=forward tooltip="include"]
"38" -> "20" [dir=forward tooltip="include"]
"38" -> "6" [dir=forward tooltip="include"]
"38" -> "39" [dir=forward tooltip="include"]
"38" -> "40" [dir=forward tooltip="include"]
"35" -> "34" [dir=forward tooltip="include"]
"35" -> "31" [dir=forward tooltip="include"]
"35" -> "32" [dir=forward tooltip="include"]
"35" -> "36" [dir=forward tooltip="include"]
"35" -> "7" [dir=forward tooltip="include"]
"37" -> "6" [dir=forward tooltip="include"]
"37" -> "2" [dir=forward tooltip="include"]
"37" -> "5" [dir=forward tooltip="include"]
"37" -> "22" [dir=forward tooltip="include"]
"37" -> "20" [dir=forward tooltip="include"]
"37" -> "38" [dir=forward tooltip="include"]
"37" -> "41" [dir=forward tooltip="include"]
"37" -> "45" [dir=forward tooltip="include"]
"41" -> "42" [dir=forward tooltip="include"]
"41" -> "2" [dir=forward tooltip="include"]
"41" -> "20" [dir=forward tooltip="include"]
"41" -> "43" [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"]
"27" -> "2" [dir=forward tooltip="include"]
"27" -> "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" -> "27" [dir=forward tooltip="include"]
"4" -> "28" [dir=forward tooltip="include"]
"4" -> "30" [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"]
}](_images/graphviz-b683e9eb46740c8ff48a7c1e0489ca3efc17351c.png)
- 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"]
}](_images/graphviz-fa690285594614563de7b0910faaf8c5faf65f0e.png)
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"]
}](_images/graphviz-304447f06ce0fbe9a611cd95b968b262a3bcadbc.png)
- file Component.H
- #include <mpi.h>#include <utility>#include <yaml-cpp/yaml.h>#include <H5Cpp.h>#include <highfive/H5File.hpp>#include <highfive/H5DataSet.hpp>#include <highfive/H5DataSpace.hpp>#include <highfive/H5Attribute.hpp>#include <EXPException.H>#include <global.H>#include <Orient.H>#include <header.H>#include <localmpi.H>#include <ParticleReader.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"]
"28" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"55" [label="CenterFile.H" tooltip="CenterFile.H"]
"58" [label="Circular.H" tooltip="Circular.H"]
"10" [label="EXPException.H" tooltip="EXPException.H"]
"51" [label="Particle.H" tooltip="Particle.H"]
"47" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"41" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"43" [label="QuadLS.H" tooltip="QuadLS.H"]
"34" [label="Species.H" tooltip="Species.H"]
"50" [label="StringTok.H" tooltip="StringTok.H"]
"30" [label="Timer.H" tooltip="Timer.H"]
"57" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"38" [label="euler.H" tooltip="euler.H"]
"52" [label="gadget.H" tooltip="gadget.H"]
"46" [label="header.H" tooltip="header.H"]
"15" [label="libvars.H" tooltip="libvars.H"]
"33" [label="localmpi.H" tooltip="localmpi.H"]
"53" [label="tipsy.H" tooltip="tipsy.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"]
"35" [label="Orient.H" tooltip="Orient.H"]
"54" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"56" [label="PotAccel.H" tooltip="PotAccel.H"]
"22" [label="chkTimer.H" tooltip="chkTimer.H"]
"21" [label="coef.H" tooltip="coef.H"]
"17" [label="global.H" tooltip="global.H"]
"39" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"5" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"40" [label="Particle.H" tooltip="Particle.H"]
"37" [label="algorithm" tooltip="algorithm"]
"42" [label="array" tooltip="array"]
"32" [label="chrono" tooltip="chrono"]
"24" [label="cmath" tooltip="cmath"]
"45" [label="config_exp.h" tooltip="config_exp.h"]
"31" [label="cstdlib" tooltip="cstdlib"]
"36" [label="deque" tooltip="deque"]
"26" [label="fstream" tooltip="fstream"]
"9" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"7" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"8" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"6" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"27" [label="iomanip" tooltip="iomanip"]
"25" [label="iostream" tooltip="iostream"]
"20" [label="list" tooltip="list"]
"29" [label="map" tooltip="map"]
"19" [label="memory" tooltip="memory"]
"2" [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"]
"49" [label="stdexcept" tooltip="stdexcept"]
"13" [label="string" tooltip="string"]
"23" [label="time.h" tooltip="time.h"]
"44" [label="tuple" tooltip="tuple"]
"48" [label="unordered_map" tooltip="unordered_map"]
"3" [label="utility" tooltip="utility"]
"12" [label="vector" tooltip="vector"]
"4" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"28" -> "25" [dir=forward tooltip="include"]
"28" -> "27" [dir=forward tooltip="include"]
"28" -> "12" [dir=forward tooltip="include"]
"28" -> "13" [dir=forward tooltip="include"]
"28" -> "20" [dir=forward tooltip="include"]
"28" -> "29" [dir=forward tooltip="include"]
"28" -> "11" [dir=forward tooltip="include"]
"28" -> "19" [dir=forward tooltip="include"]
"28" -> "30" [dir=forward tooltip="include"]
"28" -> "2" [dir=forward tooltip="include"]
"55" -> "26" [dir=forward tooltip="include"]
"55" -> "12" [dir=forward tooltip="include"]
"55" -> "42" [dir=forward tooltip="include"]
"55" -> "4" [dir=forward tooltip="include"]
"58" -> "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"]
"51" -> "48" [dir=forward tooltip="include"]
"51" -> "12" [dir=forward tooltip="include"]
"51" -> "19" [dir=forward tooltip="include"]
"47" -> "48" [dir=forward tooltip="include"]
"47" -> "49" [dir=forward tooltip="include"]
"47" -> "37" [dir=forward tooltip="include"]
"47" -> "25" [dir=forward tooltip="include"]
"47" -> "26" [dir=forward tooltip="include"]
"47" -> "27" [dir=forward tooltip="include"]
"47" -> "12" [dir=forward tooltip="include"]
"47" -> "19" [dir=forward tooltip="include"]
"47" -> "13" [dir=forward tooltip="include"]
"47" -> "24" [dir=forward tooltip="include"]
"47" -> "20" [dir=forward tooltip="include"]
"47" -> "2" [dir=forward tooltip="include"]
"47" -> "45" [dir=forward tooltip="include"]
"47" -> "50" [dir=forward tooltip="include"]
"47" -> "46" [dir=forward tooltip="include"]
"47" -> "51" [dir=forward tooltip="include"]
"47" -> "52" [dir=forward tooltip="include"]
"47" -> "53" [dir=forward tooltip="include"]
"41" -> "36" [dir=forward tooltip="include"]
"41" -> "42" [dir=forward tooltip="include"]
"41" -> "39" [dir=forward tooltip="include"]
"41" -> "43" [dir=forward tooltip="include"]
"43" -> "25" [dir=forward tooltip="include"]
"43" -> "27" [dir=forward tooltip="include"]
"43" -> "44" [dir=forward tooltip="include"]
"34" -> "29" [dir=forward tooltip="include"]
"34" -> "11" [dir=forward tooltip="include"]
"34" -> "12" [dir=forward tooltip="include"]
"30" -> "25" [dir=forward tooltip="include"]
"30" -> "31" [dir=forward tooltip="include"]
"30" -> "32" [dir=forward tooltip="include"]
"57" -> "13" [dir=forward tooltip="include"]
"57" -> "11" [dir=forward tooltip="include"]
"57" -> "4" [dir=forward tooltip="include"]
"38" -> "39" [dir=forward tooltip="include"]
"46" -> "25" [dir=forward tooltip="include"]
"46" -> "27" [dir=forward tooltip="include"]
"46" -> "14" [dir=forward tooltip="include"]
"46" -> "19" [dir=forward tooltip="include"]
"46" -> "33" [dir=forward tooltip="include"]
"15" -> "16" [dir=forward tooltip="include"]
"15" -> "2" [dir=forward tooltip="include"]
"33" -> "2" [dir=forward tooltip="include"]
"33" -> "25" [dir=forward tooltip="include"]
"33" -> "26" [dir=forward tooltip="include"]
"33" -> "27" [dir=forward tooltip="include"]
"33" -> "13" [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" -> "17" [dir=forward tooltip="include"]
"1" -> "35" [dir=forward tooltip="include"]
"1" -> "46" [dir=forward tooltip="include"]
"1" -> "33" [dir=forward tooltip="include"]
"1" -> "47" [dir=forward tooltip="include"]
"1" -> "54" [dir=forward tooltip="include"]
"1" -> "55" [dir=forward tooltip="include"]
"1" -> "56" [dir=forward tooltip="include"]
"1" -> "58" [dir=forward tooltip="include"]
"1" -> "30" [dir=forward tooltip="include"]
"1" -> "45" [dir=forward tooltip="include"]
"35" -> "12" [dir=forward tooltip="include"]
"35" -> "11" [dir=forward tooltip="include"]
"35" -> "36" [dir=forward tooltip="include"]
"35" -> "37" [dir=forward tooltip="include"]
"35" -> "38" [dir=forward tooltip="include"]
"35" -> "40" [dir=forward tooltip="include"]
"35" -> "41" [dir=forward tooltip="include"]
"35" -> "45" [dir=forward tooltip="include"]
"54" -> "12" [dir=forward tooltip="include"]
"54" -> "19" [dir=forward tooltip="include"]
"54" -> "33" [dir=forward tooltip="include"]
"54" -> "40" [dir=forward tooltip="include"]
"56" -> "31" [dir=forward tooltip="include"]
"56" -> "13" [dir=forward tooltip="include"]
"56" -> "32" [dir=forward tooltip="include"]
"56" -> "20" [dir=forward tooltip="include"]
"56" -> "29" [dir=forward tooltip="include"]
"56" -> "19" [dir=forward tooltip="include"]
"56" -> "4" [dir=forward tooltip="include"]
"56" -> "40" [dir=forward tooltip="include"]
"56" -> "50" [dir=forward tooltip="include"]
"56" -> "57" [dir=forward tooltip="include"]
"56" -> "45" [dir=forward tooltip="include"]
"22" -> "23" [dir=forward tooltip="include"]
"22" -> "24" [dir=forward tooltip="include"]
"22" -> "25" [dir=forward tooltip="include"]
"22" -> "26" [dir=forward tooltip="include"]
"22" -> "27" [dir=forward tooltip="include"]
"17" -> "18" [dir=forward tooltip="include"]
"17" -> "2" [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" -> "20" [dir=forward tooltip="include"]
"17" -> "21" [dir=forward tooltip="include"]
"17" -> "22" [dir=forward tooltip="include"]
"17" -> "28" [dir=forward tooltip="include"]
"17" -> "4" [dir=forward tooltip="include"]
"17" -> "33" [dir=forward tooltip="include"]
"17" -> "15" [dir=forward tooltip="include"]
"17" -> "34" [dir=forward tooltip="include"]
}](_images/graphviz-79f961c200d4e13b8a55125b73b7b07dc8fd8cbb.png)
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"]
}](_images/graphviz-0a2a25a4163d42260b7116be2afbd861afe03608.png)
- 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"]
"29" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"56" [label="CenterFile.H" tooltip="CenterFile.H"]
"59" [label="Circular.H" tooltip="Circular.H"]
"12" [label="EXPException.H" tooltip="EXPException.H"]
"52" [label="Particle.H" tooltip="Particle.H"]
"48" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"42" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"44" [label="QuadLS.H" tooltip="QuadLS.H"]
"35" [label="Species.H" tooltip="Species.H"]
"51" [label="StringTok.H" tooltip="StringTok.H"]
"31" [label="Timer.H" tooltip="Timer.H"]
"58" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"39" [label="euler.H" tooltip="euler.H"]
"53" [label="gadget.H" tooltip="gadget.H"]
"47" [label="header.H" tooltip="header.H"]
"17" [label="libvars.H" tooltip="libvars.H"]
"34" [label="localmpi.H" tooltip="localmpi.H"]
"54" [label="tipsy.H" tooltip="tipsy.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"]
"36" [label="Orient.H" tooltip="Orient.H"]
"55" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"57" [label="PotAccel.H" tooltip="PotAccel.H"]
"23" [label="chkTimer.H" tooltip="chkTimer.H"]
"22" [label="coef.H" tooltip="coef.H"]
"19" [label="global.H" tooltip="global.H"]
"40" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"7" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"41" [label="Particle.H" tooltip="Particle.H"]
"38" [label="algorithm" tooltip="algorithm"]
"43" [label="array" tooltip="array"]
"33" [label="chrono" tooltip="chrono"]
"25" [label="cmath" tooltip="cmath"]
"46" [label="config_exp.h" tooltip="config_exp.h"]
"32" [label="cstdlib" tooltip="cstdlib"]
"37" [label="deque" tooltip="deque"]
"27" [label="fstream" tooltip="fstream"]
"11" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"9" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"10" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"8" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"28" [label="iomanip" tooltip="iomanip"]
"26" [label="iostream" tooltip="iostream"]
"2" [label="list" tooltip="list"]
"30" [label="map" tooltip="map"]
"21" [label="memory" tooltip="memory"]
"4" [label="mpi.h" tooltip="mpi.h"]
"20" [label="pthread.h" tooltip="pthread.h"]
"18" [label="random" tooltip="random"]
"13" [label="set" tooltip="set"]
"16" [label="sstream" tooltip="sstream"]
"50" [label="stdexcept" tooltip="stdexcept"]
"15" [label="string" tooltip="string"]
"24" [label="time.h" tooltip="time.h"]
"45" [label="tuple" tooltip="tuple"]
"49" [label="unordered_map" tooltip="unordered_map"]
"5" [label="utility" tooltip="utility"]
"14" [label="vector" tooltip="vector"]
"6" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"29" -> "26" [dir=forward tooltip="include"]
"29" -> "28" [dir=forward tooltip="include"]
"29" -> "14" [dir=forward tooltip="include"]
"29" -> "15" [dir=forward tooltip="include"]
"29" -> "2" [dir=forward tooltip="include"]
"29" -> "30" [dir=forward tooltip="include"]
"29" -> "13" [dir=forward tooltip="include"]
"29" -> "21" [dir=forward tooltip="include"]
"29" -> "31" [dir=forward tooltip="include"]
"29" -> "4" [dir=forward tooltip="include"]
"56" -> "27" [dir=forward tooltip="include"]
"56" -> "14" [dir=forward tooltip="include"]
"56" -> "43" [dir=forward tooltip="include"]
"56" -> "6" [dir=forward tooltip="include"]
"59" -> "14" [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"]
"52" -> "49" [dir=forward tooltip="include"]
"52" -> "14" [dir=forward tooltip="include"]
"52" -> "21" [dir=forward tooltip="include"]
"48" -> "49" [dir=forward tooltip="include"]
"48" -> "50" [dir=forward tooltip="include"]
"48" -> "38" [dir=forward tooltip="include"]
"48" -> "26" [dir=forward tooltip="include"]
"48" -> "27" [dir=forward tooltip="include"]
"48" -> "28" [dir=forward tooltip="include"]
"48" -> "14" [dir=forward tooltip="include"]
"48" -> "21" [dir=forward tooltip="include"]
"48" -> "15" [dir=forward tooltip="include"]
"48" -> "25" [dir=forward tooltip="include"]
"48" -> "2" [dir=forward tooltip="include"]
"48" -> "4" [dir=forward tooltip="include"]
"48" -> "46" [dir=forward tooltip="include"]
"48" -> "51" [dir=forward tooltip="include"]
"48" -> "47" [dir=forward tooltip="include"]
"48" -> "52" [dir=forward tooltip="include"]
"48" -> "53" [dir=forward tooltip="include"]
"48" -> "54" [dir=forward tooltip="include"]
"42" -> "37" [dir=forward tooltip="include"]
"42" -> "43" [dir=forward tooltip="include"]
"42" -> "40" [dir=forward tooltip="include"]
"42" -> "44" [dir=forward tooltip="include"]
"44" -> "26" [dir=forward tooltip="include"]
"44" -> "28" [dir=forward tooltip="include"]
"44" -> "45" [dir=forward tooltip="include"]
"35" -> "30" [dir=forward tooltip="include"]
"35" -> "13" [dir=forward tooltip="include"]
"35" -> "14" [dir=forward tooltip="include"]
"31" -> "26" [dir=forward tooltip="include"]
"31" -> "32" [dir=forward tooltip="include"]
"31" -> "33" [dir=forward tooltip="include"]
"58" -> "15" [dir=forward tooltip="include"]
"58" -> "13" [dir=forward tooltip="include"]
"58" -> "6" [dir=forward tooltip="include"]
"39" -> "40" [dir=forward tooltip="include"]
"47" -> "26" [dir=forward tooltip="include"]
"47" -> "28" [dir=forward tooltip="include"]
"47" -> "16" [dir=forward tooltip="include"]
"47" -> "21" [dir=forward tooltip="include"]
"47" -> "34" [dir=forward tooltip="include"]
"17" -> "18" [dir=forward tooltip="include"]
"17" -> "4" [dir=forward tooltip="include"]
"34" -> "4" [dir=forward tooltip="include"]
"34" -> "26" [dir=forward tooltip="include"]
"34" -> "27" [dir=forward tooltip="include"]
"34" -> "28" [dir=forward tooltip="include"]
"34" -> "15" [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" -> "19" [dir=forward tooltip="include"]
"3" -> "36" [dir=forward tooltip="include"]
"3" -> "47" [dir=forward tooltip="include"]
"3" -> "34" [dir=forward tooltip="include"]
"3" -> "48" [dir=forward tooltip="include"]
"3" -> "55" [dir=forward tooltip="include"]
"3" -> "56" [dir=forward tooltip="include"]
"3" -> "57" [dir=forward tooltip="include"]
"3" -> "59" [dir=forward tooltip="include"]
"3" -> "31" [dir=forward tooltip="include"]
"3" -> "46" [dir=forward tooltip="include"]
"1" -> "2" [dir=forward tooltip="include"]
"1" -> "3" [dir=forward tooltip="include"]
"1" -> "31" [dir=forward tooltip="include"]
"36" -> "14" [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" -> "41" [dir=forward tooltip="include"]
"36" -> "42" [dir=forward tooltip="include"]
"36" -> "46" [dir=forward tooltip="include"]
"55" -> "14" [dir=forward tooltip="include"]
"55" -> "21" [dir=forward tooltip="include"]
"55" -> "34" [dir=forward tooltip="include"]
"55" -> "41" [dir=forward tooltip="include"]
"57" -> "32" [dir=forward tooltip="include"]
"57" -> "15" [dir=forward tooltip="include"]
"57" -> "33" [dir=forward tooltip="include"]
"57" -> "2" [dir=forward tooltip="include"]
"57" -> "30" [dir=forward tooltip="include"]
"57" -> "21" [dir=forward tooltip="include"]
"57" -> "6" [dir=forward tooltip="include"]
"57" -> "41" [dir=forward tooltip="include"]
"57" -> "51" [dir=forward tooltip="include"]
"57" -> "58" [dir=forward tooltip="include"]
"57" -> "46" [dir=forward tooltip="include"]
"23" -> "24" [dir=forward tooltip="include"]
"23" -> "25" [dir=forward tooltip="include"]
"23" -> "26" [dir=forward tooltip="include"]
"23" -> "27" [dir=forward tooltip="include"]
"23" -> "28" [dir=forward tooltip="include"]
"19" -> "20" [dir=forward tooltip="include"]
"19" -> "4" [dir=forward tooltip="include"]
"19" -> "14" [dir=forward tooltip="include"]
"19" -> "15" [dir=forward tooltip="include"]
"19" -> "21" [dir=forward tooltip="include"]
"19" -> "18" [dir=forward tooltip="include"]
"19" -> "2" [dir=forward tooltip="include"]
"19" -> "22" [dir=forward tooltip="include"]
"19" -> "23" [dir=forward tooltip="include"]
"19" -> "29" [dir=forward tooltip="include"]
"19" -> "6" [dir=forward tooltip="include"]
"19" -> "34" [dir=forward tooltip="include"]
"19" -> "17" [dir=forward tooltip="include"]
"19" -> "35" [dir=forward tooltip="include"]
}](_images/graphviz-46f132f2a763fec9c2c639bf9202003ae6d810cc.png)
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"]
}](_images/graphviz-d89524b0b855dce52f4a6660d980565dfff38c60.png)
- 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"]
"13" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"8" [label="Coefficients.H" tooltip="Coefficients.H"]
"21" [label="StringTok.H" tooltip="StringTok.H"]
"22" [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"]
"15" [label="PotAccel.H" tooltip="PotAccel.H"]
"6" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"20" [label="Particle.H" tooltip="Particle.H"]
"17" [label="chrono" tooltip="chrono"]
"2" [label="complex" tooltip="complex"]
"23" [label="config_exp.h" tooltip="config_exp.h"]
"16" [label="cstdlib" tooltip="cstdlib"]
"11" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"18" [label="list" tooltip="list"]
"19" [label="map" tooltip="map"]
"14" [label="memory" tooltip="memory"]
"5" [label="set" tooltip="set"]
"10" [label="stdexcept" tooltip="stdexcept"]
"4" [label="string" tooltip="string"]
"9" [label="tuple" tooltip="tuple"]
"7" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"3" [label="vector" tooltip="vector"]
"12" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"13" -> "14" [dir=forward tooltip="include"]
"13" -> "6" [dir=forward tooltip="include"]
"13" -> "7" [dir=forward tooltip="include"]
"8" -> "9" [dir=forward tooltip="include"]
"8" -> "10" [dir=forward tooltip="include"]
"8" -> "11" [dir=forward tooltip="include"]
"8" -> "6" [dir=forward tooltip="include"]
"8" -> "7" [dir=forward tooltip="include"]
"8" -> "12" [dir=forward tooltip="include"]
"8" -> "13" [dir=forward tooltip="include"]
"22" -> "4" [dir=forward tooltip="include"]
"22" -> "5" [dir=forward tooltip="include"]
"22" -> "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" -> "15" [dir=forward tooltip="include"]
"15" -> "16" [dir=forward tooltip="include"]
"15" -> "4" [dir=forward tooltip="include"]
"15" -> "17" [dir=forward tooltip="include"]
"15" -> "18" [dir=forward tooltip="include"]
"15" -> "19" [dir=forward tooltip="include"]
"15" -> "14" [dir=forward tooltip="include"]
"15" -> "12" [dir=forward tooltip="include"]
"15" -> "20" [dir=forward tooltip="include"]
"15" -> "21" [dir=forward tooltip="include"]
"15" -> "22" [dir=forward tooltip="include"]
"15" -> "23" [dir=forward tooltip="include"]
}](_images/graphviz-f6a26e878b0cdec12042f04df8ba704c0c05d3a5.png)
- 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"]
"60" [label="CenterFile.H" tooltip="CenterFile.H"]
"63" [label="Circular.H" tooltip="Circular.H"]
"76" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
"42" [label="EXPException.H" tooltip="EXPException.H"]
"66" [label="EmpCylSL.H" tooltip="EmpCylSL.H"]
"70" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
"56" [label="Particle.H" tooltip="Particle.H"]
"53" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"48" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"75" [label="QPDistF.H" tooltip="QPDistF.H"]
"50" [label="QuadLS.H" tooltip="QuadLS.H"]
"71" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
"26" [label="Species.H" tooltip="Species.H"]
"55" [label="StringTok.H" tooltip="StringTok.H"]
"20" [label="Timer.H" tooltip="Timer.H"]
"62" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"78" [label="coef.H" tooltip="coef.H"]
"46" [label="euler.H" tooltip="euler.H"]
"57" [label="gadget.H" tooltip="gadget.H"]
"68" [label="gaussQ.H" tooltip="gaussQ.H"]
"52" [label="header.H" tooltip="header.H"]
"69" [label="interp.H" tooltip="interp.H"]
"25" [label="libvars.H" tooltip="libvars.H"]
"24" [label="localmpi.H" tooltip="localmpi.H"]
"73" [label="massmodel.H" tooltip="massmodel.H"]
"74" [label="orbit.H" tooltip="orbit.H"]
"77" [label="sltableMP2.H" tooltip="sltableMP2.H"]
"58" [label="tipsy.H" tooltip="tipsy.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"]
"64" [label="ExternalForce.H" tooltip="ExternalForce.H"]
"43" [label="Orient.H" tooltip="Orient.H"]
"65" [label="Output.H" tooltip="Output.H"]
"59" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"61" [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"]
"37" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"47" [label="Particle.H" tooltip="Particle.H"]
"45" [label="algorithm" tooltip="algorithm"]
"49" [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"]
"44" [label="deque" tooltip="deque"]
"15" [label="fstream" tooltip="fstream"]
"67" [label="functional" tooltip="functional"]
"41" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"39" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"40" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"38" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"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"]
"72" [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"]
"51" [label="tuple" tooltip="tuple"]
"54" [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"]
"60" -> "15" [dir=forward tooltip="include"]
"60" -> "5" [dir=forward tooltip="include"]
"60" -> "49" [dir=forward tooltip="include"]
"60" -> "23" [dir=forward tooltip="include"]
"63" -> "5" [dir=forward tooltip="include"]
"76" -> "73" [dir=forward tooltip="include"]
"42" -> "19" [dir=forward tooltip="include"]
"42" -> "5" [dir=forward tooltip="include"]
"42" -> "6" [dir=forward tooltip="include"]
"42" -> "31" [dir=forward tooltip="include"]
"42" -> "25" [dir=forward tooltip="include"]
"66" -> "67" [dir=forward tooltip="include"]
"66" -> "5" [dir=forward tooltip="include"]
"66" -> "7" [dir=forward tooltip="include"]
"66" -> "32" [dir=forward tooltip="include"]
"66" -> "13" [dir=forward tooltip="include"]
"66" -> "33" [dir=forward tooltip="include"]
"66" -> "68" [dir=forward tooltip="include"]
"66" -> "69" [dir=forward tooltip="include"]
"66" -> "20" [dir=forward tooltip="include"]
"66" -> "56" [dir=forward tooltip="include"]
"66" -> "71" [dir=forward tooltip="include"]
"66" -> "78" [dir=forward tooltip="include"]
"66" -> "25" [dir=forward tooltip="include"]
"70" -> "5" [dir=forward tooltip="include"]
"70" -> "18" [dir=forward tooltip="include"]
"70" -> "6" [dir=forward tooltip="include"]
"56" -> "54" [dir=forward tooltip="include"]
"56" -> "5" [dir=forward tooltip="include"]
"56" -> "7" [dir=forward tooltip="include"]
"53" -> "54" [dir=forward tooltip="include"]
"53" -> "29" [dir=forward tooltip="include"]
"53" -> "45" [dir=forward tooltip="include"]
"53" -> "14" [dir=forward tooltip="include"]
"53" -> "15" [dir=forward tooltip="include"]
"53" -> "16" [dir=forward tooltip="include"]
"53" -> "5" [dir=forward tooltip="include"]
"53" -> "7" [dir=forward tooltip="include"]
"53" -> "6" [dir=forward tooltip="include"]
"53" -> "13" [dir=forward tooltip="include"]
"53" -> "9" [dir=forward tooltip="include"]
"53" -> "4" [dir=forward tooltip="include"]
"53" -> "28" [dir=forward tooltip="include"]
"53" -> "55" [dir=forward tooltip="include"]
"53" -> "52" [dir=forward tooltip="include"]
"53" -> "56" [dir=forward tooltip="include"]
"53" -> "57" [dir=forward tooltip="include"]
"53" -> "58" [dir=forward tooltip="include"]
"48" -> "44" [dir=forward tooltip="include"]
"48" -> "49" [dir=forward tooltip="include"]
"48" -> "33" [dir=forward tooltip="include"]
"48" -> "50" [dir=forward tooltip="include"]
"75" -> "16" [dir=forward tooltip="include"]
"75" -> "6" [dir=forward tooltip="include"]
"75" -> "18" [dir=forward tooltip="include"]
"75" -> "73" [dir=forward tooltip="include"]
"75" -> "76" [dir=forward tooltip="include"]
"75" -> "74" [dir=forward tooltip="include"]
"50" -> "14" [dir=forward tooltip="include"]
"50" -> "16" [dir=forward tooltip="include"]
"50" -> "51" [dir=forward tooltip="include"]
"71" -> "72" [dir=forward tooltip="include"]
"71" -> "14" [dir=forward tooltip="include"]
"71" -> "15" [dir=forward tooltip="include"]
"71" -> "6" [dir=forward tooltip="include"]
"71" -> "4" [dir=forward tooltip="include"]
"71" -> "24" [dir=forward tooltip="include"]
"71" -> "28" [dir=forward tooltip="include"]
"71" -> "73" [dir=forward tooltip="include"]
"71" -> "77" [dir=forward tooltip="include"]
"71" -> "23" [dir=forward tooltip="include"]
"71" -> "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"]
"62" -> "6" [dir=forward tooltip="include"]
"62" -> "19" [dir=forward tooltip="include"]
"62" -> "23" [dir=forward tooltip="include"]
"46" -> "33" [dir=forward tooltip="include"]
"68" -> "14" [dir=forward tooltip="include"]
"68" -> "16" [dir=forward tooltip="include"]
"68" -> "31" [dir=forward tooltip="include"]
"68" -> "21" [dir=forward tooltip="include"]
"68" -> "6" [dir=forward tooltip="include"]
"68" -> "5" [dir=forward tooltip="include"]
"52" -> "14" [dir=forward tooltip="include"]
"52" -> "16" [dir=forward tooltip="include"]
"52" -> "31" [dir=forward tooltip="include"]
"52" -> "7" [dir=forward tooltip="include"]
"52" -> "24" [dir=forward tooltip="include"]
"69" -> "33" [dir=forward tooltip="include"]
"69" -> "5" [dir=forward tooltip="include"]
"69" -> "44" [dir=forward tooltip="include"]
"69" -> "70" [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"]
"73" -> "5" [dir=forward tooltip="include"]
"73" -> "7" [dir=forward tooltip="include"]
"73" -> "8" [dir=forward tooltip="include"]
"73" -> "51" [dir=forward tooltip="include"]
"73" -> "33" [dir=forward tooltip="include"]
"73" -> "69" [dir=forward tooltip="include"]
"73" -> "74" [dir=forward tooltip="include"]
"73" -> "75" [dir=forward tooltip="include"]
"74" -> "67" [dir=forward tooltip="include"]
"74" -> "7" [dir=forward tooltip="include"]
"74" -> "33" [dir=forward tooltip="include"]
"74" -> "68" [dir=forward tooltip="include"]
"77" -> "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" -> "38" [dir=forward tooltip="include"]
"35" -> "39" [dir=forward tooltip="include"]
"35" -> "40" [dir=forward tooltip="include"]
"35" -> "41" [dir=forward tooltip="include"]
"35" -> "42" [dir=forward tooltip="include"]
"35" -> "2" [dir=forward tooltip="include"]
"35" -> "43" [dir=forward tooltip="include"]
"35" -> "52" [dir=forward tooltip="include"]
"35" -> "24" [dir=forward tooltip="include"]
"35" -> "53" [dir=forward tooltip="include"]
"35" -> "59" [dir=forward tooltip="include"]
"35" -> "60" [dir=forward tooltip="include"]
"35" -> "61" [dir=forward tooltip="include"]
"35" -> "63" [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" -> "66" [dir=forward tooltip="include"]
"64" -> "61" [dir=forward tooltip="include"]
"64" -> "35" [dir=forward tooltip="include"]
"43" -> "5" [dir=forward tooltip="include"]
"43" -> "19" [dir=forward tooltip="include"]
"43" -> "44" [dir=forward tooltip="include"]
"43" -> "45" [dir=forward tooltip="include"]
"43" -> "46" [dir=forward tooltip="include"]
"43" -> "47" [dir=forward tooltip="include"]
"43" -> "48" [dir=forward tooltip="include"]
"43" -> "28" [dir=forward tooltip="include"]
"65" -> "6" [dir=forward tooltip="include"]
"65" -> "5" [dir=forward tooltip="include"]
"65" -> "36" [dir=forward tooltip="include"]
"65" -> "19" [dir=forward tooltip="include"]
"65" -> "55" [dir=forward tooltip="include"]
"65" -> "20" [dir=forward tooltip="include"]
"59" -> "5" [dir=forward tooltip="include"]
"59" -> "7" [dir=forward tooltip="include"]
"59" -> "24" [dir=forward tooltip="include"]
"59" -> "47" [dir=forward tooltip="include"]
"61" -> "21" [dir=forward tooltip="include"]
"61" -> "6" [dir=forward tooltip="include"]
"61" -> "22" [dir=forward tooltip="include"]
"61" -> "9" [dir=forward tooltip="include"]
"61" -> "18" [dir=forward tooltip="include"]
"61" -> "7" [dir=forward tooltip="include"]
"61" -> "23" [dir=forward tooltip="include"]
"61" -> "47" [dir=forward tooltip="include"]
"61" -> "55" [dir=forward tooltip="include"]
"61" -> "62" [dir=forward tooltip="include"]
"61" -> "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" -> "64" [dir=forward tooltip="include"]
"27" -> "65" [dir=forward tooltip="include"]
"27" -> "23" [dir=forward tooltip="include"]
"27" -> "2" [dir=forward tooltip="include"]
"27" -> "42" [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"]
}](_images/graphviz-03247349c02a1ee4583dedeb0ea9ad9dca858fca.png)
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"]
}](_images/graphviz-db9507f1a633acba4faa9f8f96a06b97ad1166cb.png)
- 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"]
"84" [label="CoefContainer.H" tooltip="CoefContainer.H"]
"83" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"81" [label="Coefficients.H" tooltip="Coefficients.H"]
"38" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"64" [label="CenterFile.H" tooltip="CenterFile.H"]
"65" [label="Circular.H" tooltip="Circular.H"]
"78" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
"56" [label="EXPException.H" tooltip="EXPException.H"]
"68" [label="EmpCylSL.H" tooltip="EmpCylSL.H"]
"72" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
"60" [label="Particle.H" tooltip="Particle.H"]
"58" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"11" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"77" [label="QPDistF.H" tooltip="QPDistF.H"]
"13" [label="QuadLS.H" tooltip="QuadLS.H"]
"73" [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"]
"80" [label="coef.H" tooltip="coef.H"]
"8" [label="euler.H" tooltip="euler.H"]
"61" [label="gadget.H" tooltip="gadget.H"]
"70" [label="gaussQ.H" tooltip="gaussQ.H"]
"57" [label="header.H" tooltip="header.H"]
"71" [label="interp.H" tooltip="interp.H"]
"41" [label="libvars.H" tooltip="libvars.H"]
"40" [label="localmpi.H" tooltip="localmpi.H"]
"75" [label="massmodel.H" tooltip="massmodel.H"]
"76" [label="orbit.H" tooltip="orbit.H"]
"79" [label="sltableMP2.H" tooltip="sltableMP2.H"]
"62" [label="tipsy.H" tooltip="tipsy.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"]
"66" [label="ExternalForce.H" tooltip="ExternalForce.H"]
"3" [label="Orient.H" tooltip="Orient.H"]
"67" [label="Output.H" tooltip="Output.H"]
"63" [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"]
"85" [label="Eigen/Dense" tooltip="Eigen/Dense"]
"9" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"51" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"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"]
"69" [label="functional" tooltip="functional"]
"55" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"53" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"54" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"52" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"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"]
"74" [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"]
"59" [label="unordered_map" tooltip="unordered_map"]
"82" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"50" [label="utility" tooltip="utility"]
"4" [label="vector" tooltip="vector"]
"25" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"84" -> "2" [dir=forward tooltip="include"]
"84" -> "16" [dir=forward tooltip="include"]
"84" -> "24" [dir=forward tooltip="include"]
"84" -> "5" [dir=forward tooltip="include"]
"84" -> "85" [dir=forward tooltip="include"]
"84" -> "81" [dir=forward tooltip="include"]
"83" -> "2" [dir=forward tooltip="include"]
"83" -> "9" [dir=forward tooltip="include"]
"83" -> "82" [dir=forward tooltip="include"]
"81" -> "16" [dir=forward tooltip="include"]
"81" -> "44" [dir=forward tooltip="include"]
"81" -> "52" [dir=forward tooltip="include"]
"81" -> "9" [dir=forward tooltip="include"]
"81" -> "82" [dir=forward tooltip="include"]
"81" -> "25" [dir=forward tooltip="include"]
"81" -> "83" [dir=forward tooltip="include"]
"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"]
"64" -> "37" [dir=forward tooltip="include"]
"64" -> "4" [dir=forward tooltip="include"]
"64" -> "12" [dir=forward tooltip="include"]
"64" -> "25" [dir=forward tooltip="include"]
"65" -> "4" [dir=forward tooltip="include"]
"78" -> "75" [dir=forward tooltip="include"]
"56" -> "5" [dir=forward tooltip="include"]
"56" -> "4" [dir=forward tooltip="include"]
"56" -> "21" [dir=forward tooltip="include"]
"56" -> "46" [dir=forward tooltip="include"]
"56" -> "41" [dir=forward tooltip="include"]
"68" -> "69" [dir=forward tooltip="include"]
"68" -> "4" [dir=forward tooltip="include"]
"68" -> "2" [dir=forward tooltip="include"]
"68" -> "47" [dir=forward tooltip="include"]
"68" -> "36" [dir=forward tooltip="include"]
"68" -> "9" [dir=forward tooltip="include"]
"68" -> "70" [dir=forward tooltip="include"]
"68" -> "71" [dir=forward tooltip="include"]
"68" -> "39" [dir=forward tooltip="include"]
"68" -> "60" [dir=forward tooltip="include"]
"68" -> "73" [dir=forward tooltip="include"]
"68" -> "80" [dir=forward tooltip="include"]
"68" -> "41" [dir=forward tooltip="include"]
"72" -> "4" [dir=forward tooltip="include"]
"72" -> "24" [dir=forward tooltip="include"]
"72" -> "21" [dir=forward tooltip="include"]
"60" -> "59" [dir=forward tooltip="include"]
"60" -> "4" [dir=forward tooltip="include"]
"60" -> "2" [dir=forward tooltip="include"]
"58" -> "59" [dir=forward tooltip="include"]
"58" -> "44" [dir=forward tooltip="include"]
"58" -> "7" [dir=forward tooltip="include"]
"58" -> "14" [dir=forward tooltip="include"]
"58" -> "37" [dir=forward tooltip="include"]
"58" -> "15" [dir=forward tooltip="include"]
"58" -> "4" [dir=forward tooltip="include"]
"58" -> "2" [dir=forward tooltip="include"]
"58" -> "21" [dir=forward tooltip="include"]
"58" -> "36" [dir=forward tooltip="include"]
"58" -> "23" [dir=forward tooltip="include"]
"58" -> "31" [dir=forward tooltip="include"]
"58" -> "17" [dir=forward tooltip="include"]
"58" -> "26" [dir=forward tooltip="include"]
"58" -> "57" [dir=forward tooltip="include"]
"58" -> "60" [dir=forward tooltip="include"]
"58" -> "61" [dir=forward tooltip="include"]
"58" -> "62" [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"]
"77" -> "15" [dir=forward tooltip="include"]
"77" -> "21" [dir=forward tooltip="include"]
"77" -> "24" [dir=forward tooltip="include"]
"77" -> "75" [dir=forward tooltip="include"]
"77" -> "78" [dir=forward tooltip="include"]
"77" -> "76" [dir=forward tooltip="include"]
"13" -> "14" [dir=forward tooltip="include"]
"13" -> "15" [dir=forward tooltip="include"]
"13" -> "16" [dir=forward tooltip="include"]
"73" -> "74" [dir=forward tooltip="include"]
"73" -> "14" [dir=forward tooltip="include"]
"73" -> "37" [dir=forward tooltip="include"]
"73" -> "21" [dir=forward tooltip="include"]
"73" -> "31" [dir=forward tooltip="include"]
"73" -> "40" [dir=forward tooltip="include"]
"73" -> "17" [dir=forward tooltip="include"]
"73" -> "75" [dir=forward tooltip="include"]
"73" -> "79" [dir=forward tooltip="include"]
"73" -> "25" [dir=forward tooltip="include"]
"73" -> "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"]
"70" -> "14" [dir=forward tooltip="include"]
"70" -> "15" [dir=forward tooltip="include"]
"70" -> "46" [dir=forward tooltip="include"]
"70" -> "20" [dir=forward tooltip="include"]
"70" -> "21" [dir=forward tooltip="include"]
"70" -> "4" [dir=forward tooltip="include"]
"57" -> "14" [dir=forward tooltip="include"]
"57" -> "15" [dir=forward tooltip="include"]
"57" -> "46" [dir=forward tooltip="include"]
"57" -> "2" [dir=forward tooltip="include"]
"57" -> "40" [dir=forward tooltip="include"]
"71" -> "9" [dir=forward tooltip="include"]
"71" -> "4" [dir=forward tooltip="include"]
"71" -> "6" [dir=forward tooltip="include"]
"71" -> "72" [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"]
"75" -> "4" [dir=forward tooltip="include"]
"75" -> "2" [dir=forward tooltip="include"]
"75" -> "32" [dir=forward tooltip="include"]
"75" -> "16" [dir=forward tooltip="include"]
"75" -> "9" [dir=forward tooltip="include"]
"75" -> "71" [dir=forward tooltip="include"]
"75" -> "76" [dir=forward tooltip="include"]
"75" -> "77" [dir=forward tooltip="include"]
"76" -> "69" [dir=forward tooltip="include"]
"76" -> "2" [dir=forward tooltip="include"]
"76" -> "9" [dir=forward tooltip="include"]
"76" -> "70" [dir=forward tooltip="include"]
"79" -> "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" -> "52" [dir=forward tooltip="include"]
"49" -> "53" [dir=forward tooltip="include"]
"49" -> "54" [dir=forward tooltip="include"]
"49" -> "55" [dir=forward tooltip="include"]
"49" -> "56" [dir=forward tooltip="include"]
"49" -> "29" [dir=forward tooltip="include"]
"49" -> "3" [dir=forward tooltip="include"]
"49" -> "57" [dir=forward tooltip="include"]
"49" -> "40" [dir=forward tooltip="include"]
"49" -> "58" [dir=forward tooltip="include"]
"49" -> "63" [dir=forward tooltip="include"]
"49" -> "64" [dir=forward tooltip="include"]
"49" -> "19" [dir=forward tooltip="include"]
"49" -> "65" [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" -> "68" [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" -> "81" [dir=forward tooltip="include"]
"1" -> "17" [dir=forward tooltip="include"]
"1" -> "84" [dir=forward tooltip="include"]
"66" -> "19" [dir=forward tooltip="include"]
"66" -> "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"]
"67" -> "21" [dir=forward tooltip="include"]
"67" -> "4" [dir=forward tooltip="include"]
"67" -> "50" [dir=forward tooltip="include"]
"67" -> "5" [dir=forward tooltip="include"]
"67" -> "26" [dir=forward tooltip="include"]
"67" -> "39" [dir=forward tooltip="include"]
"63" -> "4" [dir=forward tooltip="include"]
"63" -> "2" [dir=forward tooltip="include"]
"63" -> "40" [dir=forward tooltip="include"]
"63" -> "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" -> "66" [dir=forward tooltip="include"]
"43" -> "67" [dir=forward tooltip="include"]
"43" -> "25" [dir=forward tooltip="include"]
"43" -> "29" [dir=forward tooltip="include"]
"43" -> "56" [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"]
}](_images/graphviz-e75392d2779c6b72d5296ed5005fe43711fcfa73.png)
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"]
}](_images/graphviz-b4d511b9a01b7b2ac1828bf1237e7e9898346cf4.png)
- file Direct.H
- #include <utility>#include <memory>#include <vector>#include <string>#include <set>#include <AxisymmetricBasis.H>#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"]
}](_images/graphviz-7401cf1a1cf803f375570118d24d9aebcb011314.png)
- 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"]
"49" [label="CoefContainer.H" tooltip="CoefContainer.H"]
"47" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"43" [label="Coefficients.H" tooltip="Coefficients.H"]
"67" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"88" [label="CenterFile.H" tooltip="CenterFile.H"]
"89" [label="Circular.H" tooltip="Circular.H"]
"28" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
"80" [label="EXPException.H" tooltip="EXPException.H"]
"92" [label="EmpCylSL.H" tooltip="EmpCylSL.H"]
"20" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
"84" [label="Particle.H" tooltip="Particle.H"]
"82" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"57" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"27" [label="QPDistF.H" tooltip="QPDistF.H"]
"59" [label="QuadLS.H" tooltip="QuadLS.H"]
"3" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
"69" [label="Species.H" tooltip="Species.H"]
"41" [label="StringTok.H" tooltip="StringTok.H"]
"68" [label="Timer.H" tooltip="Timer.H"]
"42" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"93" [label="coef.H" tooltip="coef.H"]
"56" [label="euler.H" tooltip="euler.H"]
"85" [label="gadget.H" tooltip="gadget.H"]
"24" [label="gaussQ.H" tooltip="gaussQ.H"]
"81" [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"]
"86" [label="tipsy.H" tooltip="tipsy.H"]
"35" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
"36" [label="Basis.H" tooltip="Basis.H"]
"51" [label="Bessel.H" tooltip="Bessel.H"]
"74" [label="Component.H" tooltip="Component.H"]
"73" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
"60" [label="CylEXP.H" tooltip="CylEXP.H"]
"53" [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"]
"90" [label="ExternalForce.H" tooltip="ExternalForce.H"]
"48" [label="NVTX.H" tooltip="NVTX.H"]
"54" [label="Orient.H" tooltip="Orient.H"]
"91" [label="Output.H" tooltip="Output.H"]
"87" [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"]
"64" [label="chkTimer.H" tooltip="chkTimer.H"]
"63" [label="coef.H" tooltip="coef.H"]
"70" [label="expand.H" tooltip="expand.H"]
"61" [label="global.H" tooltip="global.H"]
"50" [label="Eigen/Dense" tooltip="Eigen/Dense"]
"17" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"76" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"40" [label="Particle.H" tooltip="Particle.H"]
"55" [label="algorithm" tooltip="algorithm"]
"58" [label="array" tooltip="array"]
"52" [label="assert.h" tooltip="assert.h"]
"38" [label="chrono" tooltip="chrono"]
"66" [label="cmath" tooltip="cmath"]
"11" [label="config_exp.h" tooltip="config_exp.h"]
"26" [label="cstdlib" tooltip="cstdlib"]
"71" [label="cstring" tooltip="cstring"]
"19" [label="deque" tooltip="deque"]
"6" [label="fstream" tooltip="fstream"]
"23" [label="functional" tooltip="functional"]
"79" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"77" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"78" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"45" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"10" [label="iomanip" tooltip="iomanip"]
"5" [label="iostream" tooltip="iostream"]
"72" [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"]
"62" [label="pthread.h" tooltip="pthread.h"]
"15" [label="random" tooltip="random"]
"34" [label="set" tooltip="set"]
"25" [label="sstream" tooltip="sstream"]
"44" [label="stdexcept" tooltip="stdexcept"]
"7" [label="string" tooltip="string"]
"65" [label="time.h" tooltip="time.h"]
"16" [label="tuple" tooltip="tuple"]
"83" [label="unordered_map" tooltip="unordered_map"]
"46" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"75" [label="utility" tooltip="utility"]
"13" [label="vector" tooltip="vector"]
"30" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"49" -> "14" [dir=forward tooltip="include"]
"49" -> "16" [dir=forward tooltip="include"]
"49" -> "21" [dir=forward tooltip="include"]
"49" -> "34" [dir=forward tooltip="include"]
"49" -> "50" [dir=forward tooltip="include"]
"49" -> "43" [dir=forward tooltip="include"]
"47" -> "14" [dir=forward tooltip="include"]
"47" -> "17" [dir=forward tooltip="include"]
"47" -> "46" [dir=forward tooltip="include"]
"43" -> "16" [dir=forward tooltip="include"]
"43" -> "44" [dir=forward tooltip="include"]
"43" -> "45" [dir=forward tooltip="include"]
"43" -> "17" [dir=forward tooltip="include"]
"43" -> "46" [dir=forward tooltip="include"]
"43" -> "30" [dir=forward tooltip="include"]
"43" -> "47" [dir=forward tooltip="include"]
"67" -> "5" [dir=forward tooltip="include"]
"67" -> "10" [dir=forward tooltip="include"]
"67" -> "13" [dir=forward tooltip="include"]
"67" -> "7" [dir=forward tooltip="include"]
"67" -> "39" [dir=forward tooltip="include"]
"67" -> "21" [dir=forward tooltip="include"]
"67" -> "34" [dir=forward tooltip="include"]
"67" -> "14" [dir=forward tooltip="include"]
"67" -> "68" [dir=forward tooltip="include"]
"67" -> "8" [dir=forward tooltip="include"]
"88" -> "6" [dir=forward tooltip="include"]
"88" -> "13" [dir=forward tooltip="include"]
"88" -> "58" [dir=forward tooltip="include"]
"88" -> "30" [dir=forward tooltip="include"]
"89" -> "13" [dir=forward tooltip="include"]
"28" -> "12" [dir=forward tooltip="include"]
"80" -> "34" [dir=forward tooltip="include"]
"80" -> "13" [dir=forward tooltip="include"]
"80" -> "7" [dir=forward tooltip="include"]
"80" -> "25" [dir=forward tooltip="include"]
"80" -> "31" [dir=forward tooltip="include"]
"92" -> "23" [dir=forward tooltip="include"]
"92" -> "13" [dir=forward tooltip="include"]
"92" -> "14" [dir=forward tooltip="include"]
"92" -> "72" [dir=forward tooltip="include"]
"92" -> "66" [dir=forward tooltip="include"]
"92" -> "17" [dir=forward tooltip="include"]
"92" -> "24" [dir=forward tooltip="include"]
"92" -> "18" [dir=forward tooltip="include"]
"92" -> "68" [dir=forward tooltip="include"]
"92" -> "84" [dir=forward tooltip="include"]
"92" -> "3" [dir=forward tooltip="include"]
"92" -> "93" [dir=forward tooltip="include"]
"92" -> "31" [dir=forward tooltip="include"]
"20" -> "13" [dir=forward tooltip="include"]
"20" -> "21" [dir=forward tooltip="include"]
"20" -> "7" [dir=forward tooltip="include"]
"84" -> "83" [dir=forward tooltip="include"]
"84" -> "13" [dir=forward tooltip="include"]
"84" -> "14" [dir=forward tooltip="include"]
"82" -> "83" [dir=forward tooltip="include"]
"82" -> "44" [dir=forward tooltip="include"]
"82" -> "55" [dir=forward tooltip="include"]
"82" -> "5" [dir=forward tooltip="include"]
"82" -> "6" [dir=forward tooltip="include"]
"82" -> "10" [dir=forward tooltip="include"]
"82" -> "13" [dir=forward tooltip="include"]
"82" -> "14" [dir=forward tooltip="include"]
"82" -> "7" [dir=forward tooltip="include"]
"82" -> "66" [dir=forward tooltip="include"]
"82" -> "39" [dir=forward tooltip="include"]
"82" -> "8" [dir=forward tooltip="include"]
"82" -> "11" [dir=forward tooltip="include"]
"82" -> "41" [dir=forward tooltip="include"]
"82" -> "81" [dir=forward tooltip="include"]
"82" -> "84" [dir=forward tooltip="include"]
"82" -> "85" [dir=forward tooltip="include"]
"82" -> "86" [dir=forward tooltip="include"]
"57" -> "19" [dir=forward tooltip="include"]
"57" -> "58" [dir=forward tooltip="include"]
"57" -> "17" [dir=forward tooltip="include"]
"57" -> "59" [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"]
"59" -> "5" [dir=forward tooltip="include"]
"59" -> "10" [dir=forward tooltip="include"]
"59" -> "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"]
"69" -> "21" [dir=forward tooltip="include"]
"69" -> "34" [dir=forward tooltip="include"]
"69" -> "13" [dir=forward tooltip="include"]
"68" -> "5" [dir=forward tooltip="include"]
"68" -> "26" [dir=forward tooltip="include"]
"68" -> "38" [dir=forward tooltip="include"]
"42" -> "7" [dir=forward tooltip="include"]
"42" -> "34" [dir=forward tooltip="include"]
"42" -> "30" [dir=forward tooltip="include"]
"56" -> "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"]
"81" -> "5" [dir=forward tooltip="include"]
"81" -> "10" [dir=forward tooltip="include"]
"81" -> "25" [dir=forward tooltip="include"]
"81" -> "14" [dir=forward tooltip="include"]
"81" -> "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"]
"51" -> "52" [dir=forward tooltip="include"]
"51" -> "33" [dir=forward tooltip="include"]
"74" -> "8" [dir=forward tooltip="include"]
"74" -> "75" [dir=forward tooltip="include"]
"74" -> "30" [dir=forward tooltip="include"]
"74" -> "76" [dir=forward tooltip="include"]
"74" -> "45" [dir=forward tooltip="include"]
"74" -> "77" [dir=forward tooltip="include"]
"74" -> "78" [dir=forward tooltip="include"]
"74" -> "79" [dir=forward tooltip="include"]
"74" -> "80" [dir=forward tooltip="include"]
"74" -> "61" [dir=forward tooltip="include"]
"74" -> "54" [dir=forward tooltip="include"]
"74" -> "81" [dir=forward tooltip="include"]
"74" -> "9" [dir=forward tooltip="include"]
"74" -> "82" [dir=forward tooltip="include"]
"74" -> "87" [dir=forward tooltip="include"]
"74" -> "88" [dir=forward tooltip="include"]
"74" -> "37" [dir=forward tooltip="include"]
"74" -> "89" [dir=forward tooltip="include"]
"74" -> "68" [dir=forward tooltip="include"]
"74" -> "11" [dir=forward tooltip="include"]
"73" -> "39" [dir=forward tooltip="include"]
"73" -> "74" [dir=forward tooltip="include"]
"73" -> "68" [dir=forward tooltip="include"]
"60" -> "61" [dir=forward tooltip="include"]
"60" -> "70" [dir=forward tooltip="include"]
"60" -> "92" [dir=forward tooltip="include"]
"53" -> "14" [dir=forward tooltip="include"]
"53" -> "54" [dir=forward tooltip="include"]
"53" -> "36" [dir=forward tooltip="include"]
"53" -> "60" [dir=forward tooltip="include"]
"53" -> "43" [dir=forward tooltip="include"]
"53" -> "11" [dir=forward tooltip="include"]
"53" -> "49" [dir=forward tooltip="include"]
"1" -> "2" [dir=forward tooltip="include"]
"90" -> "37" [dir=forward tooltip="include"]
"90" -> "74" [dir=forward tooltip="include"]
"48" -> "14" [dir=forward tooltip="include"]
"48" -> "11" [dir=forward tooltip="include"]
"54" -> "13" [dir=forward tooltip="include"]
"54" -> "34" [dir=forward tooltip="include"]
"54" -> "19" [dir=forward tooltip="include"]
"54" -> "55" [dir=forward tooltip="include"]
"54" -> "56" [dir=forward tooltip="include"]
"54" -> "40" [dir=forward tooltip="include"]
"54" -> "57" [dir=forward tooltip="include"]
"54" -> "11" [dir=forward tooltip="include"]
"91" -> "7" [dir=forward tooltip="include"]
"91" -> "13" [dir=forward tooltip="include"]
"91" -> "75" [dir=forward tooltip="include"]
"91" -> "34" [dir=forward tooltip="include"]
"91" -> "41" [dir=forward tooltip="include"]
"91" -> "68" [dir=forward tooltip="include"]
"87" -> "13" [dir=forward tooltip="include"]
"87" -> "14" [dir=forward tooltip="include"]
"87" -> "9" [dir=forward tooltip="include"]
"87" -> "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" -> "48" [dir=forward tooltip="include"]
"33" -> "49" [dir=forward tooltip="include"]
"2" -> "3" [dir=forward tooltip="include"]
"2" -> "32" [dir=forward tooltip="include"]
"2" -> "51" [dir=forward tooltip="include"]
"2" -> "53" [dir=forward tooltip="include"]
"64" -> "65" [dir=forward tooltip="include"]
"64" -> "66" [dir=forward tooltip="include"]
"64" -> "5" [dir=forward tooltip="include"]
"64" -> "6" [dir=forward tooltip="include"]
"64" -> "10" [dir=forward tooltip="include"]
"70" -> "11" [dir=forward tooltip="include"]
"70" -> "8" [dir=forward tooltip="include"]
"70" -> "62" [dir=forward tooltip="include"]
"70" -> "44" [dir=forward tooltip="include"]
"70" -> "26" [dir=forward tooltip="include"]
"70" -> "66" [dir=forward tooltip="include"]
"70" -> "71" [dir=forward tooltip="include"]
"70" -> "5" [dir=forward tooltip="include"]
"70" -> "6" [dir=forward tooltip="include"]
"70" -> "25" [dir=forward tooltip="include"]
"70" -> "10" [dir=forward tooltip="include"]
"70" -> "13" [dir=forward tooltip="include"]
"70" -> "7" [dir=forward tooltip="include"]
"70" -> "72" [dir=forward tooltip="include"]
"70" -> "17" [dir=forward tooltip="include"]
"70" -> "73" [dir=forward tooltip="include"]
"70" -> "90" [dir=forward tooltip="include"]
"70" -> "91" [dir=forward tooltip="include"]
"70" -> "30" [dir=forward tooltip="include"]
"70" -> "61" [dir=forward tooltip="include"]
"70" -> "80" [dir=forward tooltip="include"]
"61" -> "62" [dir=forward tooltip="include"]
"61" -> "8" [dir=forward tooltip="include"]
"61" -> "13" [dir=forward tooltip="include"]
"61" -> "7" [dir=forward tooltip="include"]
"61" -> "14" [dir=forward tooltip="include"]
"61" -> "15" [dir=forward tooltip="include"]
"61" -> "39" [dir=forward tooltip="include"]
"61" -> "63" [dir=forward tooltip="include"]
"61" -> "64" [dir=forward tooltip="include"]
"61" -> "67" [dir=forward tooltip="include"]
"61" -> "30" [dir=forward tooltip="include"]
"61" -> "9" [dir=forward tooltip="include"]
"61" -> "31" [dir=forward tooltip="include"]
"61" -> "69" [dir=forward tooltip="include"]
}](_images/graphviz-2386700d7d33a6e998577971acd843f22c7540ed.png)
- 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"]
}](_images/graphviz-a4ce418fcf0d21d23af06cb2dfc71a11e91e13af.png)
- 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 <ComponentContainer.H>#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"]
"36" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"59" [label="CenterFile.H" tooltip="CenterFile.H"]
"62" [label="Circular.H" tooltip="Circular.H"]
"27" [label="EXPException.H" tooltip="EXPException.H"]
"55" [label="Particle.H" tooltip="Particle.H"]
"52" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"47" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"49" [label="QuadLS.H" tooltip="QuadLS.H"]
"41" [label="Species.H" tooltip="Species.H"]
"54" [label="StringTok.H" tooltip="StringTok.H"]
"38" [label="Timer.H" tooltip="Timer.H"]
"61" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"45" [label="euler.H" tooltip="euler.H"]
"56" [label="gadget.H" tooltip="gadget.H"]
"51" [label="header.H" tooltip="header.H"]
"29" [label="libvars.H" tooltip="libvars.H"]
"40" [label="localmpi.H" tooltip="localmpi.H"]
"57" [label="tipsy.H" tooltip="tipsy.H"]
"19" [label="Component.H" tooltip="Component.H"]
"17" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
"63" [label="ExternalForce.H" tooltip="ExternalForce.H"]
"42" [label="Orient.H" tooltip="Orient.H"]
"64" [label="Output.H" tooltip="Output.H"]
"58" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"60" [label="PotAccel.H" tooltip="PotAccel.H"]
"34" [label="chkTimer.H" tooltip="chkTimer.H"]
"33" [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"]
"31" [label="global.H" tooltip="global.H"]
"16" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"22" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"46" [label="Particle.H" tooltip="Particle.H"]
"44" [label="algorithm" tooltip="algorithm"]
"48" [label="array" tooltip="array"]
"39" [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"]
"43" [label="deque" tooltip="deque"]
"10" [label="fstream" tooltip="fstream"]
"26" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"24" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"25" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"23" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"12" [label="iomanip" tooltip="iomanip"]
"9" [label="iostream" tooltip="iostream"]
"15" [label="limits" tooltip="limits"]
"18" [label="list" tooltip="list"]
"37" [label="map" tooltip="map"]
"32" [label="memory" tooltip="memory"]
"3" [label="mpi.h" tooltip="mpi.h"]
"4" [label="pthread.h" tooltip="pthread.h"]
"30" [label="random" tooltip="random"]
"28" [label="set" tooltip="set"]
"11" [label="sstream" tooltip="sstream"]
"5" [label="stdexcept" tooltip="stdexcept"]
"14" [label="string" tooltip="string"]
"35" [label="time.h" tooltip="time.h"]
"50" [label="tuple" tooltip="tuple"]
"53" [label="unordered_map" tooltip="unordered_map"]
"20" [label="utility" tooltip="utility"]
"13" [label="vector" tooltip="vector"]
"21" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"36" -> "9" [dir=forward tooltip="include"]
"36" -> "12" [dir=forward tooltip="include"]
"36" -> "13" [dir=forward tooltip="include"]
"36" -> "14" [dir=forward tooltip="include"]
"36" -> "18" [dir=forward tooltip="include"]
"36" -> "37" [dir=forward tooltip="include"]
"36" -> "28" [dir=forward tooltip="include"]
"36" -> "32" [dir=forward tooltip="include"]
"36" -> "38" [dir=forward tooltip="include"]
"36" -> "3" [dir=forward tooltip="include"]
"59" -> "10" [dir=forward tooltip="include"]
"59" -> "13" [dir=forward tooltip="include"]
"59" -> "48" [dir=forward tooltip="include"]
"59" -> "21" [dir=forward tooltip="include"]
"62" -> "13" [dir=forward tooltip="include"]
"27" -> "28" [dir=forward tooltip="include"]
"27" -> "13" [dir=forward tooltip="include"]
"27" -> "14" [dir=forward tooltip="include"]
"27" -> "11" [dir=forward tooltip="include"]
"27" -> "29" [dir=forward tooltip="include"]
"55" -> "53" [dir=forward tooltip="include"]
"55" -> "13" [dir=forward tooltip="include"]
"55" -> "32" [dir=forward tooltip="include"]
"52" -> "53" [dir=forward tooltip="include"]
"52" -> "5" [dir=forward tooltip="include"]
"52" -> "44" [dir=forward tooltip="include"]
"52" -> "9" [dir=forward tooltip="include"]
"52" -> "10" [dir=forward tooltip="include"]
"52" -> "12" [dir=forward tooltip="include"]
"52" -> "13" [dir=forward tooltip="include"]
"52" -> "32" [dir=forward tooltip="include"]
"52" -> "14" [dir=forward tooltip="include"]
"52" -> "7" [dir=forward tooltip="include"]
"52" -> "18" [dir=forward tooltip="include"]
"52" -> "3" [dir=forward tooltip="include"]
"52" -> "2" [dir=forward tooltip="include"]
"52" -> "54" [dir=forward tooltip="include"]
"52" -> "51" [dir=forward tooltip="include"]
"52" -> "55" [dir=forward tooltip="include"]
"52" -> "56" [dir=forward tooltip="include"]
"52" -> "57" [dir=forward tooltip="include"]
"47" -> "43" [dir=forward tooltip="include"]
"47" -> "48" [dir=forward tooltip="include"]
"47" -> "16" [dir=forward tooltip="include"]
"47" -> "49" [dir=forward tooltip="include"]
"49" -> "9" [dir=forward tooltip="include"]
"49" -> "12" [dir=forward tooltip="include"]
"49" -> "50" [dir=forward tooltip="include"]
"41" -> "37" [dir=forward tooltip="include"]
"41" -> "28" [dir=forward tooltip="include"]
"41" -> "13" [dir=forward tooltip="include"]
"38" -> "9" [dir=forward tooltip="include"]
"38" -> "6" [dir=forward tooltip="include"]
"38" -> "39" [dir=forward tooltip="include"]
"61" -> "14" [dir=forward tooltip="include"]
"61" -> "28" [dir=forward tooltip="include"]
"61" -> "21" [dir=forward tooltip="include"]
"45" -> "16" [dir=forward tooltip="include"]
"51" -> "9" [dir=forward tooltip="include"]
"51" -> "12" [dir=forward tooltip="include"]
"51" -> "11" [dir=forward tooltip="include"]
"51" -> "32" [dir=forward tooltip="include"]
"51" -> "40" [dir=forward tooltip="include"]
"29" -> "30" [dir=forward tooltip="include"]
"29" -> "3" [dir=forward tooltip="include"]
"40" -> "3" [dir=forward tooltip="include"]
"40" -> "9" [dir=forward tooltip="include"]
"40" -> "10" [dir=forward tooltip="include"]
"40" -> "12" [dir=forward tooltip="include"]
"40" -> "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" -> "23" [dir=forward tooltip="include"]
"19" -> "24" [dir=forward tooltip="include"]
"19" -> "25" [dir=forward tooltip="include"]
"19" -> "26" [dir=forward tooltip="include"]
"19" -> "27" [dir=forward tooltip="include"]
"19" -> "31" [dir=forward tooltip="include"]
"19" -> "42" [dir=forward tooltip="include"]
"19" -> "51" [dir=forward tooltip="include"]
"19" -> "40" [dir=forward tooltip="include"]
"19" -> "52" [dir=forward tooltip="include"]
"19" -> "58" [dir=forward tooltip="include"]
"19" -> "59" [dir=forward tooltip="include"]
"19" -> "60" [dir=forward tooltip="include"]
"19" -> "62" [dir=forward tooltip="include"]
"19" -> "38" [dir=forward tooltip="include"]
"19" -> "2" [dir=forward tooltip="include"]
"17" -> "18" [dir=forward tooltip="include"]
"17" -> "19" [dir=forward tooltip="include"]
"17" -> "38" [dir=forward tooltip="include"]
"63" -> "60" [dir=forward tooltip="include"]
"63" -> "19" [dir=forward tooltip="include"]
"42" -> "13" [dir=forward tooltip="include"]
"42" -> "28" [dir=forward tooltip="include"]
"42" -> "43" [dir=forward tooltip="include"]
"42" -> "44" [dir=forward tooltip="include"]
"42" -> "45" [dir=forward tooltip="include"]
"42" -> "46" [dir=forward tooltip="include"]
"42" -> "47" [dir=forward tooltip="include"]
"42" -> "2" [dir=forward tooltip="include"]
"64" -> "14" [dir=forward tooltip="include"]
"64" -> "13" [dir=forward tooltip="include"]
"64" -> "20" [dir=forward tooltip="include"]
"64" -> "28" [dir=forward tooltip="include"]
"64" -> "54" [dir=forward tooltip="include"]
"64" -> "38" [dir=forward tooltip="include"]
"58" -> "13" [dir=forward tooltip="include"]
"58" -> "32" [dir=forward tooltip="include"]
"58" -> "40" [dir=forward tooltip="include"]
"58" -> "46" [dir=forward tooltip="include"]
"60" -> "6" [dir=forward tooltip="include"]
"60" -> "14" [dir=forward tooltip="include"]
"60" -> "39" [dir=forward tooltip="include"]
"60" -> "18" [dir=forward tooltip="include"]
"60" -> "37" [dir=forward tooltip="include"]
"60" -> "32" [dir=forward tooltip="include"]
"60" -> "21" [dir=forward tooltip="include"]
"60" -> "46" [dir=forward tooltip="include"]
"60" -> "54" [dir=forward tooltip="include"]
"60" -> "61" [dir=forward tooltip="include"]
"60" -> "2" [dir=forward tooltip="include"]
"34" -> "35" [dir=forward tooltip="include"]
"34" -> "7" [dir=forward tooltip="include"]
"34" -> "9" [dir=forward tooltip="include"]
"34" -> "10" [dir=forward tooltip="include"]
"34" -> "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" -> "63" [dir=forward tooltip="include"]
"1" -> "64" [dir=forward tooltip="include"]
"1" -> "21" [dir=forward tooltip="include"]
"1" -> "31" [dir=forward tooltip="include"]
"1" -> "27" [dir=forward tooltip="include"]
"31" -> "4" [dir=forward tooltip="include"]
"31" -> "3" [dir=forward tooltip="include"]
"31" -> "13" [dir=forward tooltip="include"]
"31" -> "14" [dir=forward tooltip="include"]
"31" -> "32" [dir=forward tooltip="include"]
"31" -> "30" [dir=forward tooltip="include"]
"31" -> "18" [dir=forward tooltip="include"]
"31" -> "33" [dir=forward tooltip="include"]
"31" -> "34" [dir=forward tooltip="include"]
"31" -> "36" [dir=forward tooltip="include"]
"31" -> "21" [dir=forward tooltip="include"]
"31" -> "40" [dir=forward tooltip="include"]
"31" -> "29" [dir=forward tooltip="include"]
"31" -> "41" [dir=forward tooltip="include"]
}](_images/graphviz-5b5813000f9e8ae41a364fbf10ef22ebcf812b17.png)
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"]
}](_images/graphviz-b51842b10f43f33d04c8781f910b4de507e4fce1.png)
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 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 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()
-
void adjust_multistep_level()
- file ExternalCollection.H
- #include <map>#include <ComponentContainer.H>#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"]
"31" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"57" [label="CenterFile.H" tooltip="CenterFile.H"]
"60" [label="Circular.H" tooltip="Circular.H"]
"14" [label="EXPException.H" tooltip="EXPException.H"]
"53" [label="Particle.H" tooltip="Particle.H"]
"49" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"43" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"45" [label="QuadLS.H" tooltip="QuadLS.H"]
"36" [label="Species.H" tooltip="Species.H"]
"52" [label="StringTok.H" tooltip="StringTok.H"]
"32" [label="Timer.H" tooltip="Timer.H"]
"59" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"40" [label="euler.H" tooltip="euler.H"]
"54" [label="gadget.H" tooltip="gadget.H"]
"48" [label="header.H" tooltip="header.H"]
"19" [label="libvars.H" tooltip="libvars.H"]
"35" [label="localmpi.H" tooltip="localmpi.H"]
"55" [label="tipsy.H" tooltip="tipsy.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"]
"61" [label="ExternalForce.H" tooltip="ExternalForce.H"]
"37" [label="Orient.H" tooltip="Orient.H"]
"56" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"58" [label="PotAccel.H" tooltip="PotAccel.H"]
"25" [label="chkTimer.H" tooltip="chkTimer.H"]
"24" [label="coef.H" tooltip="coef.H"]
"21" [label="global.H" tooltip="global.H"]
"41" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"9" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"42" [label="Particle.H" tooltip="Particle.H"]
"39" [label="algorithm" tooltip="algorithm"]
"44" [label="array" tooltip="array"]
"34" [label="chrono" tooltip="chrono"]
"27" [label="cmath" tooltip="cmath"]
"47" [label="config_exp.h" tooltip="config_exp.h"]
"33" [label="cstdlib" tooltip="cstdlib"]
"38" [label="deque" tooltip="deque"]
"29" [label="fstream" tooltip="fstream"]
"13" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"11" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"12" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"10" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"30" [label="iomanip" tooltip="iomanip"]
"28" [label="iostream" tooltip="iostream"]
"4" [label="list" tooltip="list"]
"2" [label="map" tooltip="map"]
"23" [label="memory" tooltip="memory"]
"6" [label="mpi.h" tooltip="mpi.h"]
"22" [label="pthread.h" tooltip="pthread.h"]
"20" [label="random" tooltip="random"]
"15" [label="set" tooltip="set"]
"18" [label="sstream" tooltip="sstream"]
"51" [label="stdexcept" tooltip="stdexcept"]
"17" [label="string" tooltip="string"]
"26" [label="time.h" tooltip="time.h"]
"46" [label="tuple" tooltip="tuple"]
"50" [label="unordered_map" tooltip="unordered_map"]
"7" [label="utility" tooltip="utility"]
"16" [label="vector" tooltip="vector"]
"8" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"31" -> "28" [dir=forward tooltip="include"]
"31" -> "30" [dir=forward tooltip="include"]
"31" -> "16" [dir=forward tooltip="include"]
"31" -> "17" [dir=forward tooltip="include"]
"31" -> "4" [dir=forward tooltip="include"]
"31" -> "2" [dir=forward tooltip="include"]
"31" -> "15" [dir=forward tooltip="include"]
"31" -> "23" [dir=forward tooltip="include"]
"31" -> "32" [dir=forward tooltip="include"]
"31" -> "6" [dir=forward tooltip="include"]
"57" -> "29" [dir=forward tooltip="include"]
"57" -> "16" [dir=forward tooltip="include"]
"57" -> "44" [dir=forward tooltip="include"]
"57" -> "8" [dir=forward tooltip="include"]
"60" -> "16" [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" -> "19" [dir=forward tooltip="include"]
"53" -> "50" [dir=forward tooltip="include"]
"53" -> "16" [dir=forward tooltip="include"]
"53" -> "23" [dir=forward tooltip="include"]
"49" -> "50" [dir=forward tooltip="include"]
"49" -> "51" [dir=forward tooltip="include"]
"49" -> "39" [dir=forward tooltip="include"]
"49" -> "28" [dir=forward tooltip="include"]
"49" -> "29" [dir=forward tooltip="include"]
"49" -> "30" [dir=forward tooltip="include"]
"49" -> "16" [dir=forward tooltip="include"]
"49" -> "23" [dir=forward tooltip="include"]
"49" -> "17" [dir=forward tooltip="include"]
"49" -> "27" [dir=forward tooltip="include"]
"49" -> "4" [dir=forward tooltip="include"]
"49" -> "6" [dir=forward tooltip="include"]
"49" -> "47" [dir=forward tooltip="include"]
"49" -> "52" [dir=forward tooltip="include"]
"49" -> "48" [dir=forward tooltip="include"]
"49" -> "53" [dir=forward tooltip="include"]
"49" -> "54" [dir=forward tooltip="include"]
"49" -> "55" [dir=forward tooltip="include"]
"43" -> "38" [dir=forward tooltip="include"]
"43" -> "44" [dir=forward tooltip="include"]
"43" -> "41" [dir=forward tooltip="include"]
"43" -> "45" [dir=forward tooltip="include"]
"45" -> "28" [dir=forward tooltip="include"]
"45" -> "30" [dir=forward tooltip="include"]
"45" -> "46" [dir=forward tooltip="include"]
"36" -> "2" [dir=forward tooltip="include"]
"36" -> "15" [dir=forward tooltip="include"]
"36" -> "16" [dir=forward tooltip="include"]
"32" -> "28" [dir=forward tooltip="include"]
"32" -> "33" [dir=forward tooltip="include"]
"32" -> "34" [dir=forward tooltip="include"]
"59" -> "17" [dir=forward tooltip="include"]
"59" -> "15" [dir=forward tooltip="include"]
"59" -> "8" [dir=forward tooltip="include"]
"40" -> "41" [dir=forward tooltip="include"]
"48" -> "28" [dir=forward tooltip="include"]
"48" -> "30" [dir=forward tooltip="include"]
"48" -> "18" [dir=forward tooltip="include"]
"48" -> "23" [dir=forward tooltip="include"]
"48" -> "35" [dir=forward tooltip="include"]
"19" -> "20" [dir=forward tooltip="include"]
"19" -> "6" [dir=forward tooltip="include"]
"35" -> "6" [dir=forward tooltip="include"]
"35" -> "28" [dir=forward tooltip="include"]
"35" -> "29" [dir=forward tooltip="include"]
"35" -> "30" [dir=forward tooltip="include"]
"35" -> "17" [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" -> "21" [dir=forward tooltip="include"]
"5" -> "37" [dir=forward tooltip="include"]
"5" -> "48" [dir=forward tooltip="include"]
"5" -> "35" [dir=forward tooltip="include"]
"5" -> "49" [dir=forward tooltip="include"]
"5" -> "56" [dir=forward tooltip="include"]
"5" -> "57" [dir=forward tooltip="include"]
"5" -> "58" [dir=forward tooltip="include"]
"5" -> "60" [dir=forward tooltip="include"]
"5" -> "32" [dir=forward tooltip="include"]
"5" -> "47" [dir=forward tooltip="include"]
"3" -> "4" [dir=forward tooltip="include"]
"3" -> "5" [dir=forward tooltip="include"]
"3" -> "32" [dir=forward tooltip="include"]
"1" -> "2" [dir=forward tooltip="include"]
"1" -> "3" [dir=forward tooltip="include"]
"1" -> "61" [dir=forward tooltip="include"]
"61" -> "58" [dir=forward tooltip="include"]
"61" -> "5" [dir=forward tooltip="include"]
"37" -> "16" [dir=forward tooltip="include"]
"37" -> "15" [dir=forward tooltip="include"]
"37" -> "38" [dir=forward tooltip="include"]
"37" -> "39" [dir=forward tooltip="include"]
"37" -> "40" [dir=forward tooltip="include"]
"37" -> "42" [dir=forward tooltip="include"]
"37" -> "43" [dir=forward tooltip="include"]
"37" -> "47" [dir=forward tooltip="include"]
"56" -> "16" [dir=forward tooltip="include"]
"56" -> "23" [dir=forward tooltip="include"]
"56" -> "35" [dir=forward tooltip="include"]
"56" -> "42" [dir=forward tooltip="include"]
"58" -> "33" [dir=forward tooltip="include"]
"58" -> "17" [dir=forward tooltip="include"]
"58" -> "34" [dir=forward tooltip="include"]
"58" -> "4" [dir=forward tooltip="include"]
"58" -> "2" [dir=forward tooltip="include"]
"58" -> "23" [dir=forward tooltip="include"]
"58" -> "8" [dir=forward tooltip="include"]
"58" -> "42" [dir=forward tooltip="include"]
"58" -> "52" [dir=forward tooltip="include"]
"58" -> "59" [dir=forward tooltip="include"]
"58" -> "47" [dir=forward tooltip="include"]
"25" -> "26" [dir=forward tooltip="include"]
"25" -> "27" [dir=forward tooltip="include"]
"25" -> "28" [dir=forward tooltip="include"]
"25" -> "29" [dir=forward tooltip="include"]
"25" -> "30" [dir=forward tooltip="include"]
"21" -> "22" [dir=forward tooltip="include"]
"21" -> "6" [dir=forward tooltip="include"]
"21" -> "16" [dir=forward tooltip="include"]
"21" -> "17" [dir=forward tooltip="include"]
"21" -> "23" [dir=forward tooltip="include"]
"21" -> "20" [dir=forward tooltip="include"]
"21" -> "4" [dir=forward tooltip="include"]
"21" -> "24" [dir=forward tooltip="include"]
"21" -> "25" [dir=forward tooltip="include"]
"21" -> "31" [dir=forward tooltip="include"]
"21" -> "8" [dir=forward tooltip="include"]
"21" -> "35" [dir=forward tooltip="include"]
"21" -> "19" [dir=forward tooltip="include"]
"21" -> "36" [dir=forward tooltip="include"]
}](_images/graphviz-60cb188e0fd52ca35b0e6f1a330a4e30c1edf5c6.png)
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"]
}](_images/graphviz-32140dc8c0fb945a68c1e41288e0849bbdfd5194.png)
- 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"]
"37" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"58" [label="CenterFile.H" tooltip="CenterFile.H"]
"59" [label="Circular.H" tooltip="Circular.H"]
"23" [label="EXPException.H" tooltip="EXPException.H"]
"54" [label="Particle.H" tooltip="Particle.H"]
"51" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"46" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"48" [label="QuadLS.H" tooltip="QuadLS.H"]
"40" [label="Species.H" tooltip="Species.H"]
"11" [label="StringTok.H" tooltip="StringTok.H"]
"38" [label="Timer.H" tooltip="Timer.H"]
"12" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"44" [label="euler.H" tooltip="euler.H"]
"55" [label="gadget.H" tooltip="gadget.H"]
"50" [label="header.H" tooltip="header.H"]
"26" [label="libvars.H" tooltip="libvars.H"]
"39" [label="localmpi.H" tooltip="localmpi.H"]
"56" [label="tipsy.H" tooltip="tipsy.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"]
"41" [label="Orient.H" tooltip="Orient.H"]
"57" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"2" [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"]
"45" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"18" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"10" [label="Particle.H" tooltip="Particle.H"]
"43" [label="algorithm" tooltip="algorithm"]
"47" [label="array" tooltip="array"]
"5" [label="chrono" tooltip="chrono"]
"33" [label="cmath" tooltip="cmath"]
"14" [label="config_exp.h" tooltip="config_exp.h"]
"3" [label="cstdlib" tooltip="cstdlib"]
"42" [label="deque" tooltip="deque"]
"35" [label="fstream" tooltip="fstream"]
"22" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"20" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"21" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"19" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"36" [label="iomanip" tooltip="iomanip"]
"34" [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"]
"29" [label="pthread.h" tooltip="pthread.h"]
"27" [label="random" tooltip="random"]
"13" [label="set" tooltip="set"]
"25" [label="sstream" tooltip="sstream"]
"53" [label="stdexcept" tooltip="stdexcept"]
"4" [label="string" tooltip="string"]
"32" [label="time.h" tooltip="time.h"]
"49" [label="tuple" tooltip="tuple"]
"52" [label="unordered_map" tooltip="unordered_map"]
"17" [label="utility" tooltip="utility"]
"24" [label="vector" tooltip="vector"]
"9" [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" -> "4" [dir=forward tooltip="include"]
"37" -> "6" [dir=forward tooltip="include"]
"37" -> "7" [dir=forward tooltip="include"]
"37" -> "13" [dir=forward tooltip="include"]
"37" -> "8" [dir=forward tooltip="include"]
"37" -> "38" [dir=forward tooltip="include"]
"37" -> "16" [dir=forward tooltip="include"]
"58" -> "35" [dir=forward tooltip="include"]
"58" -> "24" [dir=forward tooltip="include"]
"58" -> "47" [dir=forward tooltip="include"]
"58" -> "9" [dir=forward tooltip="include"]
"59" -> "24" [dir=forward tooltip="include"]
"23" -> "13" [dir=forward tooltip="include"]
"23" -> "24" [dir=forward tooltip="include"]
"23" -> "4" [dir=forward tooltip="include"]
"23" -> "25" [dir=forward tooltip="include"]
"23" -> "26" [dir=forward tooltip="include"]
"54" -> "52" [dir=forward tooltip="include"]
"54" -> "24" [dir=forward tooltip="include"]
"54" -> "8" [dir=forward tooltip="include"]
"51" -> "52" [dir=forward tooltip="include"]
"51" -> "53" [dir=forward tooltip="include"]
"51" -> "43" [dir=forward tooltip="include"]
"51" -> "34" [dir=forward tooltip="include"]
"51" -> "35" [dir=forward tooltip="include"]
"51" -> "36" [dir=forward tooltip="include"]
"51" -> "24" [dir=forward tooltip="include"]
"51" -> "8" [dir=forward tooltip="include"]
"51" -> "4" [dir=forward tooltip="include"]
"51" -> "33" [dir=forward tooltip="include"]
"51" -> "6" [dir=forward tooltip="include"]
"51" -> "16" [dir=forward tooltip="include"]
"51" -> "14" [dir=forward tooltip="include"]
"51" -> "11" [dir=forward tooltip="include"]
"51" -> "50" [dir=forward tooltip="include"]
"51" -> "54" [dir=forward tooltip="include"]
"51" -> "55" [dir=forward tooltip="include"]
"51" -> "56" [dir=forward tooltip="include"]
"46" -> "42" [dir=forward tooltip="include"]
"46" -> "47" [dir=forward tooltip="include"]
"46" -> "45" [dir=forward tooltip="include"]
"46" -> "48" [dir=forward tooltip="include"]
"48" -> "34" [dir=forward tooltip="include"]
"48" -> "36" [dir=forward tooltip="include"]
"48" -> "49" [dir=forward tooltip="include"]
"40" -> "7" [dir=forward tooltip="include"]
"40" -> "13" [dir=forward tooltip="include"]
"40" -> "24" [dir=forward tooltip="include"]
"38" -> "34" [dir=forward tooltip="include"]
"38" -> "3" [dir=forward tooltip="include"]
"38" -> "5" [dir=forward tooltip="include"]
"12" -> "4" [dir=forward tooltip="include"]
"12" -> "13" [dir=forward tooltip="include"]
"12" -> "9" [dir=forward tooltip="include"]
"44" -> "45" [dir=forward tooltip="include"]
"50" -> "34" [dir=forward tooltip="include"]
"50" -> "36" [dir=forward tooltip="include"]
"50" -> "25" [dir=forward tooltip="include"]
"50" -> "8" [dir=forward tooltip="include"]
"50" -> "39" [dir=forward tooltip="include"]
"26" -> "27" [dir=forward tooltip="include"]
"26" -> "16" [dir=forward tooltip="include"]
"39" -> "16" [dir=forward tooltip="include"]
"39" -> "34" [dir=forward tooltip="include"]
"39" -> "35" [dir=forward tooltip="include"]
"39" -> "36" [dir=forward tooltip="include"]
"39" -> "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" -> "19" [dir=forward tooltip="include"]
"15" -> "20" [dir=forward tooltip="include"]
"15" -> "21" [dir=forward tooltip="include"]
"15" -> "22" [dir=forward tooltip="include"]
"15" -> "23" [dir=forward tooltip="include"]
"15" -> "28" [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" -> "57" [dir=forward tooltip="include"]
"15" -> "58" [dir=forward tooltip="include"]
"15" -> "2" [dir=forward tooltip="include"]
"15" -> "59" [dir=forward tooltip="include"]
"15" -> "38" [dir=forward tooltip="include"]
"15" -> "14" [dir=forward tooltip="include"]
"1" -> "2" [dir=forward tooltip="include"]
"1" -> "15" [dir=forward tooltip="include"]
"41" -> "24" [dir=forward tooltip="include"]
"41" -> "13" [dir=forward tooltip="include"]
"41" -> "42" [dir=forward tooltip="include"]
"41" -> "43" [dir=forward tooltip="include"]
"41" -> "44" [dir=forward tooltip="include"]
"41" -> "10" [dir=forward tooltip="include"]
"41" -> "46" [dir=forward tooltip="include"]
"41" -> "14" [dir=forward tooltip="include"]
"57" -> "24" [dir=forward tooltip="include"]
"57" -> "8" [dir=forward tooltip="include"]
"57" -> "39" [dir=forward tooltip="include"]
"57" -> "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"]
"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" -> "16" [dir=forward tooltip="include"]
"28" -> "24" [dir=forward tooltip="include"]
"28" -> "4" [dir=forward tooltip="include"]
"28" -> "8" [dir=forward tooltip="include"]
"28" -> "27" [dir=forward tooltip="include"]
"28" -> "6" [dir=forward tooltip="include"]
"28" -> "30" [dir=forward tooltip="include"]
"28" -> "31" [dir=forward tooltip="include"]
"28" -> "37" [dir=forward tooltip="include"]
"28" -> "9" [dir=forward tooltip="include"]
"28" -> "39" [dir=forward tooltip="include"]
"28" -> "26" [dir=forward tooltip="include"]
"28" -> "40" [dir=forward tooltip="include"]
}](_images/graphviz-ea4ea6a4dd8ae39c01627f15646f74fbaed8fbfa.png)
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"]
}](_images/graphviz-de5b4d644a1e1828d65a794abc98877c57f02d92.png)
Typedefs
-
typedef ExternalForce *maker_t(const YAML::Node&)
-
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"]
}](_images/graphviz-a1b32673e939487f81194840cdee16ad83b5fbf6.png)
- 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"]
"55" [label="CoefContainer.H" tooltip="CoefContainer.H"]
"53" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"50" [label="Coefficients.H" tooltip="Coefficients.H"]
"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"]
"54" [label="NVTX.H" tooltip="NVTX.H"]
"40" [label="PolarBasis.H" tooltip="PolarBasis.H"]
"44" [label="PotAccel.H" tooltip="PotAccel.H"]
"56" [label="Eigen/Dense" tooltip="Eigen/Dense"]
"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"]
"51" [label="stdexcept" tooltip="stdexcept"]
"7" [label="string" tooltip="string"]
"17" [label="tuple" tooltip="tuple"]
"52" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"15" [label="vector" tooltip="vector"]
"28" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"55" -> "2" [dir=forward tooltip="include"]
"55" -> "17" [dir=forward tooltip="include"]
"55" -> "3" [dir=forward tooltip="include"]
"55" -> "41" [dir=forward tooltip="include"]
"55" -> "56" [dir=forward tooltip="include"]
"55" -> "50" [dir=forward tooltip="include"]
"53" -> "2" [dir=forward tooltip="include"]
"53" -> "9" [dir=forward tooltip="include"]
"53" -> "52" [dir=forward tooltip="include"]
"50" -> "17" [dir=forward tooltip="include"]
"50" -> "51" [dir=forward tooltip="include"]
"50" -> "29" [dir=forward tooltip="include"]
"50" -> "9" [dir=forward tooltip="include"]
"50" -> "52" [dir=forward tooltip="include"]
"50" -> "28" [dir=forward tooltip="include"]
"50" -> "53" [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" -> "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"]
"54" -> "2" [dir=forward tooltip="include"]
"54" -> "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" -> "54" [dir=forward tooltip="include"]
"40" -> "55" [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"]
}](_images/graphviz-881815fadc85bc0a677a6049a24c7a51aec13804.png)
- 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"]
}](_images/graphviz-d46d26d344348d71090fb30a4cc0b2e53d579e45.png)
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"]
}](_images/graphviz-2c1996ef068a0a16d27216bc7872c605e5ac02a2.png)
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
-
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.
-
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.
-
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)
-
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.
-
BarrierWrapper *barrier
- file global_key_set.H
- 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"]
}](_images/graphviz-a2bc93b043d3994f5300bdeca02aa798421d66bf.png)
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"]
}](_images/graphviz-2b8bb7d36e65a7c3a5570ba19df81ba062e9b643.png)
- 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"]
"38" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"59" [label="CenterFile.H" tooltip="CenterFile.H"]
"60" [label="Circular.H" tooltip="Circular.H"]
"25" [label="EXPException.H" tooltip="EXPException.H"]
"55" [label="Particle.H" tooltip="Particle.H"]
"52" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"47" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"49" [label="QuadLS.H" tooltip="QuadLS.H"]
"41" [label="Species.H" tooltip="Species.H"]
"14" [label="StringTok.H" tooltip="StringTok.H"]
"39" [label="Timer.H" tooltip="Timer.H"]
"15" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"45" [label="euler.H" tooltip="euler.H"]
"56" [label="gadget.H" tooltip="gadget.H"]
"51" [label="header.H" tooltip="header.H"]
"27" [label="libvars.H" tooltip="libvars.H"]
"40" [label="localmpi.H" tooltip="localmpi.H"]
"57" [label="tipsy.H" tooltip="tipsy.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"]
"42" [label="Orient.H" tooltip="Orient.H"]
"58" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"6" [label="PotAccel.H" tooltip="PotAccel.H"]
"32" [label="chkTimer.H" tooltip="chkTimer.H"]
"31" [label="coef.H" tooltip="coef.H"]
"29" [label="global.H" tooltip="global.H"]
"46" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"20" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"13" [label="Particle.H" tooltip="Particle.H"]
"44" [label="algorithm" tooltip="algorithm"]
"48" [label="array" tooltip="array"]
"8" [label="chrono" tooltip="chrono"]
"34" [label="cmath" tooltip="cmath"]
"16" [label="config_exp.h" tooltip="config_exp.h"]
"7" [label="cstdlib" tooltip="cstdlib"]
"43" [label="deque" tooltip="deque"]
"36" [label="fstream" tooltip="fstream"]
"24" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"22" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"23" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"21" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"37" [label="iomanip" tooltip="iomanip"]
"35" [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"]
"30" [label="pthread.h" tooltip="pthread.h"]
"28" [label="random" tooltip="random"]
"4" [label="set" tooltip="set"]
"26" [label="sstream" tooltip="sstream"]
"54" [label="stdexcept" tooltip="stdexcept"]
"2" [label="string" tooltip="string"]
"33" [label="time.h" tooltip="time.h"]
"50" [label="tuple" tooltip="tuple"]
"53" [label="unordered_map" tooltip="unordered_map"]
"19" [label="utility" tooltip="utility"]
"3" [label="vector" tooltip="vector"]
"12" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"38" -> "35" [dir=forward tooltip="include"]
"38" -> "37" [dir=forward tooltip="include"]
"38" -> "3" [dir=forward tooltip="include"]
"38" -> "2" [dir=forward tooltip="include"]
"38" -> "9" [dir=forward tooltip="include"]
"38" -> "10" [dir=forward tooltip="include"]
"38" -> "4" [dir=forward tooltip="include"]
"38" -> "11" [dir=forward tooltip="include"]
"38" -> "39" [dir=forward tooltip="include"]
"38" -> "18" [dir=forward tooltip="include"]
"59" -> "36" [dir=forward tooltip="include"]
"59" -> "3" [dir=forward tooltip="include"]
"59" -> "48" [dir=forward tooltip="include"]
"59" -> "12" [dir=forward tooltip="include"]
"60" -> "3" [dir=forward tooltip="include"]
"25" -> "4" [dir=forward tooltip="include"]
"25" -> "3" [dir=forward tooltip="include"]
"25" -> "2" [dir=forward tooltip="include"]
"25" -> "26" [dir=forward tooltip="include"]
"25" -> "27" [dir=forward tooltip="include"]
"55" -> "53" [dir=forward tooltip="include"]
"55" -> "3" [dir=forward tooltip="include"]
"55" -> "11" [dir=forward tooltip="include"]
"52" -> "53" [dir=forward tooltip="include"]
"52" -> "54" [dir=forward tooltip="include"]
"52" -> "44" [dir=forward tooltip="include"]
"52" -> "35" [dir=forward tooltip="include"]
"52" -> "36" [dir=forward tooltip="include"]
"52" -> "37" [dir=forward tooltip="include"]
"52" -> "3" [dir=forward tooltip="include"]
"52" -> "11" [dir=forward tooltip="include"]
"52" -> "2" [dir=forward tooltip="include"]
"52" -> "34" [dir=forward tooltip="include"]
"52" -> "9" [dir=forward tooltip="include"]
"52" -> "18" [dir=forward tooltip="include"]
"52" -> "16" [dir=forward tooltip="include"]
"52" -> "14" [dir=forward tooltip="include"]
"52" -> "51" [dir=forward tooltip="include"]
"52" -> "55" [dir=forward tooltip="include"]
"52" -> "56" [dir=forward tooltip="include"]
"52" -> "57" [dir=forward tooltip="include"]
"47" -> "43" [dir=forward tooltip="include"]
"47" -> "48" [dir=forward tooltip="include"]
"47" -> "46" [dir=forward tooltip="include"]
"47" -> "49" [dir=forward tooltip="include"]
"49" -> "35" [dir=forward tooltip="include"]
"49" -> "37" [dir=forward tooltip="include"]
"49" -> "50" [dir=forward tooltip="include"]
"41" -> "10" [dir=forward tooltip="include"]
"41" -> "4" [dir=forward tooltip="include"]
"41" -> "3" [dir=forward tooltip="include"]
"39" -> "35" [dir=forward tooltip="include"]
"39" -> "7" [dir=forward tooltip="include"]
"39" -> "8" [dir=forward tooltip="include"]
"15" -> "2" [dir=forward tooltip="include"]
"15" -> "4" [dir=forward tooltip="include"]
"15" -> "12" [dir=forward tooltip="include"]
"45" -> "46" [dir=forward tooltip="include"]
"51" -> "35" [dir=forward tooltip="include"]
"51" -> "37" [dir=forward tooltip="include"]
"51" -> "26" [dir=forward tooltip="include"]
"51" -> "11" [dir=forward tooltip="include"]
"51" -> "40" [dir=forward tooltip="include"]
"27" -> "28" [dir=forward tooltip="include"]
"27" -> "18" [dir=forward tooltip="include"]
"40" -> "18" [dir=forward tooltip="include"]
"40" -> "35" [dir=forward tooltip="include"]
"40" -> "36" [dir=forward tooltip="include"]
"40" -> "37" [dir=forward tooltip="include"]
"40" -> "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" -> "21" [dir=forward tooltip="include"]
"17" -> "22" [dir=forward tooltip="include"]
"17" -> "23" [dir=forward tooltip="include"]
"17" -> "24" [dir=forward tooltip="include"]
"17" -> "25" [dir=forward tooltip="include"]
"17" -> "29" [dir=forward tooltip="include"]
"17" -> "42" [dir=forward tooltip="include"]
"17" -> "51" [dir=forward tooltip="include"]
"17" -> "40" [dir=forward tooltip="include"]
"17" -> "52" [dir=forward tooltip="include"]
"17" -> "58" [dir=forward tooltip="include"]
"17" -> "59" [dir=forward tooltip="include"]
"17" -> "6" [dir=forward tooltip="include"]
"17" -> "60" [dir=forward tooltip="include"]
"17" -> "39" [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"]
"42" -> "3" [dir=forward tooltip="include"]
"42" -> "4" [dir=forward tooltip="include"]
"42" -> "43" [dir=forward tooltip="include"]
"42" -> "44" [dir=forward tooltip="include"]
"42" -> "45" [dir=forward tooltip="include"]
"42" -> "13" [dir=forward tooltip="include"]
"42" -> "47" [dir=forward tooltip="include"]
"42" -> "16" [dir=forward tooltip="include"]
"58" -> "3" [dir=forward tooltip="include"]
"58" -> "11" [dir=forward tooltip="include"]
"58" -> "40" [dir=forward tooltip="include"]
"58" -> "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"]
"32" -> "33" [dir=forward tooltip="include"]
"32" -> "34" [dir=forward tooltip="include"]
"32" -> "35" [dir=forward tooltip="include"]
"32" -> "36" [dir=forward tooltip="include"]
"32" -> "37" [dir=forward tooltip="include"]
"29" -> "30" [dir=forward tooltip="include"]
"29" -> "18" [dir=forward tooltip="include"]
"29" -> "3" [dir=forward tooltip="include"]
"29" -> "2" [dir=forward tooltip="include"]
"29" -> "11" [dir=forward tooltip="include"]
"29" -> "28" [dir=forward tooltip="include"]
"29" -> "9" [dir=forward tooltip="include"]
"29" -> "31" [dir=forward tooltip="include"]
"29" -> "32" [dir=forward tooltip="include"]
"29" -> "38" [dir=forward tooltip="include"]
"29" -> "12" [dir=forward tooltip="include"]
"29" -> "40" [dir=forward tooltip="include"]
"29" -> "27" [dir=forward tooltip="include"]
"29" -> "41" [dir=forward tooltip="include"]
}](_images/graphviz-f694612150b36eb12fa2c8c7da51bd9413899eb1.png)
- 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"]
"49" [label="CoefContainer.H" tooltip="CoefContainer.H"]
"47" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"43" [label="Coefficients.H" tooltip="Coefficients.H"]
"67" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"88" [label="CenterFile.H" tooltip="CenterFile.H"]
"89" [label="Circular.H" tooltip="Circular.H"]
"28" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
"80" [label="EXPException.H" tooltip="EXPException.H"]
"92" [label="EmpCylSL.H" tooltip="EmpCylSL.H"]
"20" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
"84" [label="Particle.H" tooltip="Particle.H"]
"82" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"57" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"27" [label="QPDistF.H" tooltip="QPDistF.H"]
"59" [label="QuadLS.H" tooltip="QuadLS.H"]
"3" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
"69" [label="Species.H" tooltip="Species.H"]
"41" [label="StringTok.H" tooltip="StringTok.H"]
"68" [label="Timer.H" tooltip="Timer.H"]
"42" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"93" [label="coef.H" tooltip="coef.H"]
"56" [label="euler.H" tooltip="euler.H"]
"85" [label="gadget.H" tooltip="gadget.H"]
"24" [label="gaussQ.H" tooltip="gaussQ.H"]
"81" [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"]
"86" [label="tipsy.H" tooltip="tipsy.H"]
"35" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
"36" [label="Basis.H" tooltip="Basis.H"]
"51" [label="Bessel.H" tooltip="Bessel.H"]
"74" [label="Component.H" tooltip="Component.H"]
"73" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
"60" [label="CylEXP.H" tooltip="CylEXP.H"]
"53" [label="Cylinder.H" tooltip="Cylinder.H"]
"90" [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"]
"48" [label="NVTX.H" tooltip="NVTX.H"]
"54" [label="Orient.H" tooltip="Orient.H"]
"91" [label="Output.H" tooltip="Output.H"]
"87" [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"]
"64" [label="chkTimer.H" tooltip="chkTimer.H"]
"63" [label="coef.H" tooltip="coef.H"]
"70" [label="expand.H" tooltip="expand.H"]
"61" [label="global.H" tooltip="global.H"]
"50" [label="Eigen/Dense" tooltip="Eigen/Dense"]
"17" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"76" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"40" [label="Particle.H" tooltip="Particle.H"]
"55" [label="algorithm" tooltip="algorithm"]
"58" [label="array" tooltip="array"]
"52" [label="assert.h" tooltip="assert.h"]
"38" [label="chrono" tooltip="chrono"]
"66" [label="cmath" tooltip="cmath"]
"11" [label="config_exp.h" tooltip="config_exp.h"]
"26" [label="cstdlib" tooltip="cstdlib"]
"71" [label="cstring" tooltip="cstring"]
"19" [label="deque" tooltip="deque"]
"6" [label="fstream" tooltip="fstream"]
"23" [label="functional" tooltip="functional"]
"79" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"77" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"78" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"45" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"10" [label="iomanip" tooltip="iomanip"]
"5" [label="iostream" tooltip="iostream"]
"72" [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"]
"62" [label="pthread.h" tooltip="pthread.h"]
"15" [label="random" tooltip="random"]
"34" [label="set" tooltip="set"]
"25" [label="sstream" tooltip="sstream"]
"44" [label="stdexcept" tooltip="stdexcept"]
"7" [label="string" tooltip="string"]
"65" [label="time.h" tooltip="time.h"]
"16" [label="tuple" tooltip="tuple"]
"83" [label="unordered_map" tooltip="unordered_map"]
"46" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"75" [label="utility" tooltip="utility"]
"13" [label="vector" tooltip="vector"]
"30" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"49" -> "14" [dir=forward tooltip="include"]
"49" -> "16" [dir=forward tooltip="include"]
"49" -> "21" [dir=forward tooltip="include"]
"49" -> "34" [dir=forward tooltip="include"]
"49" -> "50" [dir=forward tooltip="include"]
"49" -> "43" [dir=forward tooltip="include"]
"47" -> "14" [dir=forward tooltip="include"]
"47" -> "17" [dir=forward tooltip="include"]
"47" -> "46" [dir=forward tooltip="include"]
"43" -> "16" [dir=forward tooltip="include"]
"43" -> "44" [dir=forward tooltip="include"]
"43" -> "45" [dir=forward tooltip="include"]
"43" -> "17" [dir=forward tooltip="include"]
"43" -> "46" [dir=forward tooltip="include"]
"43" -> "30" [dir=forward tooltip="include"]
"43" -> "47" [dir=forward tooltip="include"]
"67" -> "5" [dir=forward tooltip="include"]
"67" -> "10" [dir=forward tooltip="include"]
"67" -> "13" [dir=forward tooltip="include"]
"67" -> "7" [dir=forward tooltip="include"]
"67" -> "39" [dir=forward tooltip="include"]
"67" -> "21" [dir=forward tooltip="include"]
"67" -> "34" [dir=forward tooltip="include"]
"67" -> "14" [dir=forward tooltip="include"]
"67" -> "68" [dir=forward tooltip="include"]
"67" -> "8" [dir=forward tooltip="include"]
"88" -> "6" [dir=forward tooltip="include"]
"88" -> "13" [dir=forward tooltip="include"]
"88" -> "58" [dir=forward tooltip="include"]
"88" -> "30" [dir=forward tooltip="include"]
"89" -> "13" [dir=forward tooltip="include"]
"28" -> "12" [dir=forward tooltip="include"]
"80" -> "34" [dir=forward tooltip="include"]
"80" -> "13" [dir=forward tooltip="include"]
"80" -> "7" [dir=forward tooltip="include"]
"80" -> "25" [dir=forward tooltip="include"]
"80" -> "31" [dir=forward tooltip="include"]
"92" -> "23" [dir=forward tooltip="include"]
"92" -> "13" [dir=forward tooltip="include"]
"92" -> "14" [dir=forward tooltip="include"]
"92" -> "72" [dir=forward tooltip="include"]
"92" -> "66" [dir=forward tooltip="include"]
"92" -> "17" [dir=forward tooltip="include"]
"92" -> "24" [dir=forward tooltip="include"]
"92" -> "18" [dir=forward tooltip="include"]
"92" -> "68" [dir=forward tooltip="include"]
"92" -> "84" [dir=forward tooltip="include"]
"92" -> "3" [dir=forward tooltip="include"]
"92" -> "93" [dir=forward tooltip="include"]
"92" -> "31" [dir=forward tooltip="include"]
"20" -> "13" [dir=forward tooltip="include"]
"20" -> "21" [dir=forward tooltip="include"]
"20" -> "7" [dir=forward tooltip="include"]
"84" -> "83" [dir=forward tooltip="include"]
"84" -> "13" [dir=forward tooltip="include"]
"84" -> "14" [dir=forward tooltip="include"]
"82" -> "83" [dir=forward tooltip="include"]
"82" -> "44" [dir=forward tooltip="include"]
"82" -> "55" [dir=forward tooltip="include"]
"82" -> "5" [dir=forward tooltip="include"]
"82" -> "6" [dir=forward tooltip="include"]
"82" -> "10" [dir=forward tooltip="include"]
"82" -> "13" [dir=forward tooltip="include"]
"82" -> "14" [dir=forward tooltip="include"]
"82" -> "7" [dir=forward tooltip="include"]
"82" -> "66" [dir=forward tooltip="include"]
"82" -> "39" [dir=forward tooltip="include"]
"82" -> "8" [dir=forward tooltip="include"]
"82" -> "11" [dir=forward tooltip="include"]
"82" -> "41" [dir=forward tooltip="include"]
"82" -> "81" [dir=forward tooltip="include"]
"82" -> "84" [dir=forward tooltip="include"]
"82" -> "85" [dir=forward tooltip="include"]
"82" -> "86" [dir=forward tooltip="include"]
"57" -> "19" [dir=forward tooltip="include"]
"57" -> "58" [dir=forward tooltip="include"]
"57" -> "17" [dir=forward tooltip="include"]
"57" -> "59" [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"]
"59" -> "5" [dir=forward tooltip="include"]
"59" -> "10" [dir=forward tooltip="include"]
"59" -> "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"]
"69" -> "21" [dir=forward tooltip="include"]
"69" -> "34" [dir=forward tooltip="include"]
"69" -> "13" [dir=forward tooltip="include"]
"68" -> "5" [dir=forward tooltip="include"]
"68" -> "26" [dir=forward tooltip="include"]
"68" -> "38" [dir=forward tooltip="include"]
"42" -> "7" [dir=forward tooltip="include"]
"42" -> "34" [dir=forward tooltip="include"]
"42" -> "30" [dir=forward tooltip="include"]
"56" -> "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"]
"81" -> "5" [dir=forward tooltip="include"]
"81" -> "10" [dir=forward tooltip="include"]
"81" -> "25" [dir=forward tooltip="include"]
"81" -> "14" [dir=forward tooltip="include"]
"81" -> "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"]
"51" -> "52" [dir=forward tooltip="include"]
"51" -> "33" [dir=forward tooltip="include"]
"74" -> "8" [dir=forward tooltip="include"]
"74" -> "75" [dir=forward tooltip="include"]
"74" -> "30" [dir=forward tooltip="include"]
"74" -> "76" [dir=forward tooltip="include"]
"74" -> "45" [dir=forward tooltip="include"]
"74" -> "77" [dir=forward tooltip="include"]
"74" -> "78" [dir=forward tooltip="include"]
"74" -> "79" [dir=forward tooltip="include"]
"74" -> "80" [dir=forward tooltip="include"]
"74" -> "61" [dir=forward tooltip="include"]
"74" -> "54" [dir=forward tooltip="include"]
"74" -> "81" [dir=forward tooltip="include"]
"74" -> "9" [dir=forward tooltip="include"]
"74" -> "82" [dir=forward tooltip="include"]
"74" -> "87" [dir=forward tooltip="include"]
"74" -> "88" [dir=forward tooltip="include"]
"74" -> "37" [dir=forward tooltip="include"]
"74" -> "89" [dir=forward tooltip="include"]
"74" -> "68" [dir=forward tooltip="include"]
"74" -> "11" [dir=forward tooltip="include"]
"73" -> "39" [dir=forward tooltip="include"]
"73" -> "74" [dir=forward tooltip="include"]
"73" -> "68" [dir=forward tooltip="include"]
"60" -> "61" [dir=forward tooltip="include"]
"60" -> "70" [dir=forward tooltip="include"]
"60" -> "92" [dir=forward tooltip="include"]
"53" -> "14" [dir=forward tooltip="include"]
"53" -> "54" [dir=forward tooltip="include"]
"53" -> "36" [dir=forward tooltip="include"]
"53" -> "60" [dir=forward tooltip="include"]
"53" -> "43" [dir=forward tooltip="include"]
"53" -> "11" [dir=forward tooltip="include"]
"53" -> "49" [dir=forward tooltip="include"]
"90" -> "37" [dir=forward tooltip="include"]
"90" -> "74" [dir=forward tooltip="include"]
"1" -> "2" [dir=forward tooltip="include"]
"48" -> "14" [dir=forward tooltip="include"]
"48" -> "11" [dir=forward tooltip="include"]
"54" -> "13" [dir=forward tooltip="include"]
"54" -> "34" [dir=forward tooltip="include"]
"54" -> "19" [dir=forward tooltip="include"]
"54" -> "55" [dir=forward tooltip="include"]
"54" -> "56" [dir=forward tooltip="include"]
"54" -> "40" [dir=forward tooltip="include"]
"54" -> "57" [dir=forward tooltip="include"]
"54" -> "11" [dir=forward tooltip="include"]
"91" -> "7" [dir=forward tooltip="include"]
"91" -> "13" [dir=forward tooltip="include"]
"91" -> "75" [dir=forward tooltip="include"]
"91" -> "34" [dir=forward tooltip="include"]
"91" -> "41" [dir=forward tooltip="include"]
"91" -> "68" [dir=forward tooltip="include"]
"87" -> "13" [dir=forward tooltip="include"]
"87" -> "14" [dir=forward tooltip="include"]
"87" -> "9" [dir=forward tooltip="include"]
"87" -> "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" -> "48" [dir=forward tooltip="include"]
"33" -> "49" [dir=forward tooltip="include"]
"2" -> "3" [dir=forward tooltip="include"]
"2" -> "32" [dir=forward tooltip="include"]
"2" -> "51" [dir=forward tooltip="include"]
"2" -> "53" [dir=forward tooltip="include"]
"64" -> "65" [dir=forward tooltip="include"]
"64" -> "66" [dir=forward tooltip="include"]
"64" -> "5" [dir=forward tooltip="include"]
"64" -> "6" [dir=forward tooltip="include"]
"64" -> "10" [dir=forward tooltip="include"]
"70" -> "11" [dir=forward tooltip="include"]
"70" -> "8" [dir=forward tooltip="include"]
"70" -> "62" [dir=forward tooltip="include"]
"70" -> "44" [dir=forward tooltip="include"]
"70" -> "26" [dir=forward tooltip="include"]
"70" -> "66" [dir=forward tooltip="include"]
"70" -> "71" [dir=forward tooltip="include"]
"70" -> "5" [dir=forward tooltip="include"]
"70" -> "6" [dir=forward tooltip="include"]
"70" -> "25" [dir=forward tooltip="include"]
"70" -> "10" [dir=forward tooltip="include"]
"70" -> "13" [dir=forward tooltip="include"]
"70" -> "7" [dir=forward tooltip="include"]
"70" -> "72" [dir=forward tooltip="include"]
"70" -> "17" [dir=forward tooltip="include"]
"70" -> "73" [dir=forward tooltip="include"]
"70" -> "90" [dir=forward tooltip="include"]
"70" -> "91" [dir=forward tooltip="include"]
"70" -> "30" [dir=forward tooltip="include"]
"70" -> "61" [dir=forward tooltip="include"]
"70" -> "80" [dir=forward tooltip="include"]
"61" -> "62" [dir=forward tooltip="include"]
"61" -> "8" [dir=forward tooltip="include"]
"61" -> "13" [dir=forward tooltip="include"]
"61" -> "7" [dir=forward tooltip="include"]
"61" -> "14" [dir=forward tooltip="include"]
"61" -> "15" [dir=forward tooltip="include"]
"61" -> "39" [dir=forward tooltip="include"]
"61" -> "63" [dir=forward tooltip="include"]
"61" -> "64" [dir=forward tooltip="include"]
"61" -> "67" [dir=forward tooltip="include"]
"61" -> "30" [dir=forward tooltip="include"]
"61" -> "9" [dir=forward tooltip="include"]
"61" -> "31" [dir=forward tooltip="include"]
"61" -> "69" [dir=forward tooltip="include"]
}](_images/graphviz-6db1d2f78c99f581e30d503f8e5c7397985e82d0.png)
Defines
-
CALL_MEMBER_FN(object, ptrToMember)
-
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"]
}](_images/graphviz-d8ea2fc36b5f5001b63fc70f44aa6332d27e4fd0.png)
- 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"]
}](_images/graphviz-9dce5f0bc7cd3e9ac959077bd8e0719b8724c013.png)
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"]
}](_images/graphviz-650c316847bd97ff340270301742a16a8e10fc09.png)
- 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"]
}](_images/graphviz-c7d3f50dbb9521906cb986f7afc3b3f1b0000e4e.png)
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"]
}](_images/graphviz-497ab549e87e221a10e3a45b462655ef799f91fa.png)
- 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"]
}](_images/graphviz-ddd9e88168705f3a2c7ac049305ae208c310ff77.png)
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"]
}](_images/graphviz-0b47113b7a3db05f9e01516cd4b5d6fe702c15c0.png)
Variables
-
bool use_cuda
-
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"]
"29" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"56" [label="CenterFile.H" tooltip="CenterFile.H"]
"59" [label="Circular.H" tooltip="Circular.H"]
"11" [label="EXPException.H" tooltip="EXPException.H"]
"52" [label="Particle.H" tooltip="Particle.H"]
"48" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"42" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"44" [label="QuadLS.H" tooltip="QuadLS.H"]
"35" [label="Species.H" tooltip="Species.H"]
"51" [label="StringTok.H" tooltip="StringTok.H"]
"31" [label="Timer.H" tooltip="Timer.H"]
"58" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"39" [label="euler.H" tooltip="euler.H"]
"53" [label="gadget.H" tooltip="gadget.H"]
"47" [label="header.H" tooltip="header.H"]
"16" [label="libvars.H" tooltip="libvars.H"]
"34" [label="localmpi.H" tooltip="localmpi.H"]
"54" [label="tipsy.H" tooltip="tipsy.H"]
"2" [label="Component.H" tooltip="Component.H"]
"36" [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"]
"55" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"57" [label="PotAccel.H" tooltip="PotAccel.H"]
"23" [label="chkTimer.H" tooltip="chkTimer.H"]
"22" [label="coef.H" tooltip="coef.H"]
"18" [label="global.H" tooltip="global.H"]
"40" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"6" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"41" [label="Particle.H" tooltip="Particle.H"]
"38" [label="algorithm" tooltip="algorithm"]
"43" [label="array" tooltip="array"]
"33" [label="chrono" tooltip="chrono"]
"25" [label="cmath" tooltip="cmath"]
"46" [label="config_exp.h" tooltip="config_exp.h"]
"32" [label="cstdlib" tooltip="cstdlib"]
"37" [label="deque" tooltip="deque"]
"27" [label="fstream" tooltip="fstream"]
"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"]
"28" [label="iomanip" tooltip="iomanip"]
"26" [label="iostream" tooltip="iostream"]
"21" [label="list" tooltip="list"]
"30" [label="map" tooltip="map"]
"20" [label="memory" tooltip="memory"]
"3" [label="mpi.h" tooltip="mpi.h"]
"19" [label="pthread.h" tooltip="pthread.h"]
"17" [label="random" tooltip="random"]
"12" [label="set" tooltip="set"]
"15" [label="sstream" tooltip="sstream"]
"50" [label="stdexcept" tooltip="stdexcept"]
"14" [label="string" tooltip="string"]
"24" [label="time.h" tooltip="time.h"]
"45" [label="tuple" tooltip="tuple"]
"49" [label="unordered_map" tooltip="unordered_map"]
"4" [label="utility" tooltip="utility"]
"13" [label="vector" tooltip="vector"]
"5" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"29" -> "26" [dir=forward tooltip="include"]
"29" -> "28" [dir=forward tooltip="include"]
"29" -> "13" [dir=forward tooltip="include"]
"29" -> "14" [dir=forward tooltip="include"]
"29" -> "21" [dir=forward tooltip="include"]
"29" -> "30" [dir=forward tooltip="include"]
"29" -> "12" [dir=forward tooltip="include"]
"29" -> "20" [dir=forward tooltip="include"]
"29" -> "31" [dir=forward tooltip="include"]
"29" -> "3" [dir=forward tooltip="include"]
"56" -> "27" [dir=forward tooltip="include"]
"56" -> "13" [dir=forward tooltip="include"]
"56" -> "43" [dir=forward tooltip="include"]
"56" -> "5" [dir=forward tooltip="include"]
"59" -> "13" [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"]
"52" -> "49" [dir=forward tooltip="include"]
"52" -> "13" [dir=forward tooltip="include"]
"52" -> "20" [dir=forward tooltip="include"]
"48" -> "49" [dir=forward tooltip="include"]
"48" -> "50" [dir=forward tooltip="include"]
"48" -> "38" [dir=forward tooltip="include"]
"48" -> "26" [dir=forward tooltip="include"]
"48" -> "27" [dir=forward tooltip="include"]
"48" -> "28" [dir=forward tooltip="include"]
"48" -> "13" [dir=forward tooltip="include"]
"48" -> "20" [dir=forward tooltip="include"]
"48" -> "14" [dir=forward tooltip="include"]
"48" -> "25" [dir=forward tooltip="include"]
"48" -> "21" [dir=forward tooltip="include"]
"48" -> "3" [dir=forward tooltip="include"]
"48" -> "46" [dir=forward tooltip="include"]
"48" -> "51" [dir=forward tooltip="include"]
"48" -> "47" [dir=forward tooltip="include"]
"48" -> "52" [dir=forward tooltip="include"]
"48" -> "53" [dir=forward tooltip="include"]
"48" -> "54" [dir=forward tooltip="include"]
"42" -> "37" [dir=forward tooltip="include"]
"42" -> "43" [dir=forward tooltip="include"]
"42" -> "40" [dir=forward tooltip="include"]
"42" -> "44" [dir=forward tooltip="include"]
"44" -> "26" [dir=forward tooltip="include"]
"44" -> "28" [dir=forward tooltip="include"]
"44" -> "45" [dir=forward tooltip="include"]
"35" -> "30" [dir=forward tooltip="include"]
"35" -> "12" [dir=forward tooltip="include"]
"35" -> "13" [dir=forward tooltip="include"]
"31" -> "26" [dir=forward tooltip="include"]
"31" -> "32" [dir=forward tooltip="include"]
"31" -> "33" [dir=forward tooltip="include"]
"58" -> "14" [dir=forward tooltip="include"]
"58" -> "12" [dir=forward tooltip="include"]
"58" -> "5" [dir=forward tooltip="include"]
"39" -> "40" [dir=forward tooltip="include"]
"47" -> "26" [dir=forward tooltip="include"]
"47" -> "28" [dir=forward tooltip="include"]
"47" -> "15" [dir=forward tooltip="include"]
"47" -> "20" [dir=forward tooltip="include"]
"47" -> "34" [dir=forward tooltip="include"]
"16" -> "17" [dir=forward tooltip="include"]
"16" -> "3" [dir=forward tooltip="include"]
"34" -> "3" [dir=forward tooltip="include"]
"34" -> "26" [dir=forward tooltip="include"]
"34" -> "27" [dir=forward tooltip="include"]
"34" -> "28" [dir=forward tooltip="include"]
"34" -> "14" [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" -> "18" [dir=forward tooltip="include"]
"2" -> "36" [dir=forward tooltip="include"]
"2" -> "47" [dir=forward tooltip="include"]
"2" -> "34" [dir=forward tooltip="include"]
"2" -> "48" [dir=forward tooltip="include"]
"2" -> "55" [dir=forward tooltip="include"]
"2" -> "56" [dir=forward tooltip="include"]
"2" -> "57" [dir=forward tooltip="include"]
"2" -> "59" [dir=forward tooltip="include"]
"2" -> "31" [dir=forward tooltip="include"]
"2" -> "46" [dir=forward tooltip="include"]
"36" -> "13" [dir=forward tooltip="include"]
"36" -> "12" [dir=forward tooltip="include"]
"36" -> "37" [dir=forward tooltip="include"]
"36" -> "38" [dir=forward tooltip="include"]
"36" -> "39" [dir=forward tooltip="include"]
"36" -> "41" [dir=forward tooltip="include"]
"36" -> "42" [dir=forward tooltip="include"]
"36" -> "46" [dir=forward tooltip="include"]
"1" -> "2" [dir=forward tooltip="include"]
"1" -> "1" [dir=forward tooltip="include"]
"55" -> "13" [dir=forward tooltip="include"]
"55" -> "20" [dir=forward tooltip="include"]
"55" -> "34" [dir=forward tooltip="include"]
"55" -> "41" [dir=forward tooltip="include"]
"57" -> "32" [dir=forward tooltip="include"]
"57" -> "14" [dir=forward tooltip="include"]
"57" -> "33" [dir=forward tooltip="include"]
"57" -> "21" [dir=forward tooltip="include"]
"57" -> "30" [dir=forward tooltip="include"]
"57" -> "20" [dir=forward tooltip="include"]
"57" -> "5" [dir=forward tooltip="include"]
"57" -> "41" [dir=forward tooltip="include"]
"57" -> "51" [dir=forward tooltip="include"]
"57" -> "58" [dir=forward tooltip="include"]
"57" -> "46" [dir=forward tooltip="include"]
"23" -> "24" [dir=forward tooltip="include"]
"23" -> "25" [dir=forward tooltip="include"]
"23" -> "26" [dir=forward tooltip="include"]
"23" -> "27" [dir=forward tooltip="include"]
"23" -> "28" [dir=forward tooltip="include"]
"18" -> "19" [dir=forward tooltip="include"]
"18" -> "3" [dir=forward tooltip="include"]
"18" -> "13" [dir=forward tooltip="include"]
"18" -> "14" [dir=forward tooltip="include"]
"18" -> "20" [dir=forward tooltip="include"]
"18" -> "17" [dir=forward tooltip="include"]
"18" -> "21" [dir=forward tooltip="include"]
"18" -> "22" [dir=forward tooltip="include"]
"18" -> "23" [dir=forward tooltip="include"]
"18" -> "29" [dir=forward tooltip="include"]
"18" -> "5" [dir=forward tooltip="include"]
"18" -> "34" [dir=forward tooltip="include"]
"18" -> "16" [dir=forward tooltip="include"]
"18" -> "35" [dir=forward tooltip="include"]
}](_images/graphviz-94ee0631586984109f89621a2d9877e945890d40.png)
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"]
}](_images/graphviz-46f06e6fb824a8838c56c85623f630883a8be922.png)
- 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"]
"34" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"57" [label="CenterFile.H" tooltip="CenterFile.H"]
"60" [label="Circular.H" tooltip="Circular.H"]
"20" [label="EXPException.H" tooltip="EXPException.H"]
"53" [label="Particle.H" tooltip="Particle.H"]
"50" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"44" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"46" [label="QuadLS.H" tooltip="QuadLS.H"]
"37" [label="Species.H" tooltip="Species.H"]
"7" [label="StringTok.H" tooltip="StringTok.H"]
"8" [label="Timer.H" tooltip="Timer.H"]
"59" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"41" [label="euler.H" tooltip="euler.H"]
"54" [label="gadget.H" tooltip="gadget.H"]
"49" [label="header.H" tooltip="header.H"]
"22" [label="libvars.H" tooltip="libvars.H"]
"36" [label="localmpi.H" tooltip="localmpi.H"]
"55" [label="tipsy.H" tooltip="tipsy.H"]
"12" [label="Component.H" tooltip="Component.H"]
"38" [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"]
"56" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"58" [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"]
"42" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"15" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"43" [label="Particle.H" tooltip="Particle.H"]
"40" [label="algorithm" tooltip="algorithm"]
"45" [label="array" tooltip="array"]
"11" [label="chrono" tooltip="chrono"]
"31" [label="cmath" tooltip="cmath"]
"48" [label="config_exp.h" tooltip="config_exp.h"]
"10" [label="cstdlib" tooltip="cstdlib"]
"39" [label="deque" tooltip="deque"]
"32" [label="fstream" tooltip="fstream"]
"19" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"17" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"18" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"16" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"33" [label="iomanip" tooltip="iomanip"]
"9" [label="iostream" tooltip="iostream"]
"27" [label="list" tooltip="list"]
"35" [label="map" tooltip="map"]
"26" [label="memory" tooltip="memory"]
"13" [label="mpi.h" tooltip="mpi.h"]
"25" [label="pthread.h" tooltip="pthread.h"]
"23" [label="random" tooltip="random"]
"6" [label="set" tooltip="set"]
"21" [label="sstream" tooltip="sstream"]
"52" [label="stdexcept" tooltip="stdexcept"]
"3" [label="string" tooltip="string"]
"30" [label="time.h" tooltip="time.h"]
"47" [label="tuple" tooltip="tuple"]
"51" [label="unordered_map" tooltip="unordered_map"]
"5" [label="utility" tooltip="utility"]
"4" [label="vector" tooltip="vector"]
"14" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"34" -> "9" [dir=forward tooltip="include"]
"34" -> "33" [dir=forward tooltip="include"]
"34" -> "4" [dir=forward tooltip="include"]
"34" -> "3" [dir=forward tooltip="include"]
"34" -> "27" [dir=forward tooltip="include"]
"34" -> "35" [dir=forward tooltip="include"]
"34" -> "6" [dir=forward tooltip="include"]
"34" -> "26" [dir=forward tooltip="include"]
"34" -> "8" [dir=forward tooltip="include"]
"34" -> "13" [dir=forward tooltip="include"]
"57" -> "32" [dir=forward tooltip="include"]
"57" -> "4" [dir=forward tooltip="include"]
"57" -> "45" [dir=forward tooltip="include"]
"57" -> "14" [dir=forward tooltip="include"]
"60" -> "4" [dir=forward tooltip="include"]
"20" -> "6" [dir=forward tooltip="include"]
"20" -> "4" [dir=forward tooltip="include"]
"20" -> "3" [dir=forward tooltip="include"]
"20" -> "21" [dir=forward tooltip="include"]
"20" -> "22" [dir=forward tooltip="include"]
"53" -> "51" [dir=forward tooltip="include"]
"53" -> "4" [dir=forward tooltip="include"]
"53" -> "26" [dir=forward tooltip="include"]
"50" -> "51" [dir=forward tooltip="include"]
"50" -> "52" [dir=forward tooltip="include"]
"50" -> "40" [dir=forward tooltip="include"]
"50" -> "9" [dir=forward tooltip="include"]
"50" -> "32" [dir=forward tooltip="include"]
"50" -> "33" [dir=forward tooltip="include"]
"50" -> "4" [dir=forward tooltip="include"]
"50" -> "26" [dir=forward tooltip="include"]
"50" -> "3" [dir=forward tooltip="include"]
"50" -> "31" [dir=forward tooltip="include"]
"50" -> "27" [dir=forward tooltip="include"]
"50" -> "13" [dir=forward tooltip="include"]
"50" -> "48" [dir=forward tooltip="include"]
"50" -> "7" [dir=forward tooltip="include"]
"50" -> "49" [dir=forward tooltip="include"]
"50" -> "53" [dir=forward tooltip="include"]
"50" -> "54" [dir=forward tooltip="include"]
"50" -> "55" [dir=forward tooltip="include"]
"44" -> "39" [dir=forward tooltip="include"]
"44" -> "45" [dir=forward tooltip="include"]
"44" -> "42" [dir=forward tooltip="include"]
"44" -> "46" [dir=forward tooltip="include"]
"46" -> "9" [dir=forward tooltip="include"]
"46" -> "33" [dir=forward tooltip="include"]
"46" -> "47" [dir=forward tooltip="include"]
"37" -> "35" [dir=forward tooltip="include"]
"37" -> "6" [dir=forward tooltip="include"]
"37" -> "4" [dir=forward tooltip="include"]
"8" -> "9" [dir=forward tooltip="include"]
"8" -> "10" [dir=forward tooltip="include"]
"8" -> "11" [dir=forward tooltip="include"]
"59" -> "3" [dir=forward tooltip="include"]
"59" -> "6" [dir=forward tooltip="include"]
"59" -> "14" [dir=forward tooltip="include"]
"41" -> "42" [dir=forward tooltip="include"]
"49" -> "9" [dir=forward tooltip="include"]
"49" -> "33" [dir=forward tooltip="include"]
"49" -> "21" [dir=forward tooltip="include"]
"49" -> "26" [dir=forward tooltip="include"]
"49" -> "36" [dir=forward tooltip="include"]
"22" -> "23" [dir=forward tooltip="include"]
"22" -> "13" [dir=forward tooltip="include"]
"36" -> "13" [dir=forward tooltip="include"]
"36" -> "9" [dir=forward tooltip="include"]
"36" -> "32" [dir=forward tooltip="include"]
"36" -> "33" [dir=forward tooltip="include"]
"36" -> "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" -> "16" [dir=forward tooltip="include"]
"12" -> "17" [dir=forward tooltip="include"]
"12" -> "18" [dir=forward tooltip="include"]
"12" -> "19" [dir=forward tooltip="include"]
"12" -> "20" [dir=forward tooltip="include"]
"12" -> "24" [dir=forward tooltip="include"]
"12" -> "38" [dir=forward tooltip="include"]
"12" -> "49" [dir=forward tooltip="include"]
"12" -> "36" [dir=forward tooltip="include"]
"12" -> "50" [dir=forward tooltip="include"]
"12" -> "56" [dir=forward tooltip="include"]
"12" -> "57" [dir=forward tooltip="include"]
"12" -> "58" [dir=forward tooltip="include"]
"12" -> "60" [dir=forward tooltip="include"]
"12" -> "8" [dir=forward tooltip="include"]
"12" -> "48" [dir=forward tooltip="include"]
"38" -> "4" [dir=forward tooltip="include"]
"38" -> "6" [dir=forward tooltip="include"]
"38" -> "39" [dir=forward tooltip="include"]
"38" -> "40" [dir=forward tooltip="include"]
"38" -> "41" [dir=forward tooltip="include"]
"38" -> "43" [dir=forward tooltip="include"]
"38" -> "44" [dir=forward tooltip="include"]
"38" -> "48" [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"]
"56" -> "4" [dir=forward tooltip="include"]
"56" -> "26" [dir=forward tooltip="include"]
"56" -> "36" [dir=forward tooltip="include"]
"56" -> "43" [dir=forward tooltip="include"]
"58" -> "10" [dir=forward tooltip="include"]
"58" -> "3" [dir=forward tooltip="include"]
"58" -> "11" [dir=forward tooltip="include"]
"58" -> "27" [dir=forward tooltip="include"]
"58" -> "35" [dir=forward tooltip="include"]
"58" -> "26" [dir=forward tooltip="include"]
"58" -> "14" [dir=forward tooltip="include"]
"58" -> "43" [dir=forward tooltip="include"]
"58" -> "7" [dir=forward tooltip="include"]
"58" -> "59" [dir=forward tooltip="include"]
"58" -> "48" [dir=forward tooltip="include"]
"29" -> "30" [dir=forward tooltip="include"]
"29" -> "31" [dir=forward tooltip="include"]
"29" -> "9" [dir=forward tooltip="include"]
"29" -> "32" [dir=forward tooltip="include"]
"29" -> "33" [dir=forward tooltip="include"]
"24" -> "25" [dir=forward tooltip="include"]
"24" -> "13" [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" -> "34" [dir=forward tooltip="include"]
"24" -> "14" [dir=forward tooltip="include"]
"24" -> "36" [dir=forward tooltip="include"]
"24" -> "22" [dir=forward tooltip="include"]
"24" -> "37" [dir=forward tooltip="include"]
}](_images/graphviz-ba500a3fa0a0feb0b91c1965b62eb40894679673.png)
- 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"]
}](_images/graphviz-595a50e868b1c87e8417685ee50f02fbfb476914.png)
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"]
}](_images/graphviz-bafd1f4520eec6f17d65bd620b0a5b48c70185aa.png)
- 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"]
}](_images/graphviz-fba5aed461379faf4b3750d4f9a56ce5f505d088.png)
- 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"]
}](_images/graphviz-24ff044e2517fd137a86c51ca20692079246a13c.png)
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"]
}](_images/graphviz-43482d7a3d747d48db950ce6150598bc4f9c4511.png)
- 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"]
}](_images/graphviz-4cde62977c3f9c632679e49c3fe7c50282ad6e66.png)
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"]
}](_images/graphviz-ecf6e0f3444c3c883cf2c096ba155ea37228a0b2.png)
- 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"]
"34" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"57" [label="CenterFile.H" tooltip="CenterFile.H"]
"60" [label="Circular.H" tooltip="Circular.H"]
"20" [label="EXPException.H" tooltip="EXPException.H"]
"53" [label="Particle.H" tooltip="Particle.H"]
"50" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"44" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"46" [label="QuadLS.H" tooltip="QuadLS.H"]
"37" [label="Species.H" tooltip="Species.H"]
"7" [label="StringTok.H" tooltip="StringTok.H"]
"8" [label="Timer.H" tooltip="Timer.H"]
"59" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"41" [label="euler.H" tooltip="euler.H"]
"54" [label="gadget.H" tooltip="gadget.H"]
"49" [label="header.H" tooltip="header.H"]
"22" [label="libvars.H" tooltip="libvars.H"]
"36" [label="localmpi.H" tooltip="localmpi.H"]
"55" [label="tipsy.H" tooltip="tipsy.H"]
"12" [label="Component.H" tooltip="Component.H"]
"38" [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"]
"56" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"58" [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"]
"42" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"15" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"43" [label="Particle.H" tooltip="Particle.H"]
"40" [label="algorithm" tooltip="algorithm"]
"45" [label="array" tooltip="array"]
"11" [label="chrono" tooltip="chrono"]
"31" [label="cmath" tooltip="cmath"]
"48" [label="config_exp.h" tooltip="config_exp.h"]
"10" [label="cstdlib" tooltip="cstdlib"]
"39" [label="deque" tooltip="deque"]
"32" [label="fstream" tooltip="fstream"]
"19" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"17" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"18" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"16" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"33" [label="iomanip" tooltip="iomanip"]
"9" [label="iostream" tooltip="iostream"]
"27" [label="list" tooltip="list"]
"35" [label="map" tooltip="map"]
"26" [label="memory" tooltip="memory"]
"13" [label="mpi.h" tooltip="mpi.h"]
"25" [label="pthread.h" tooltip="pthread.h"]
"23" [label="random" tooltip="random"]
"6" [label="set" tooltip="set"]
"21" [label="sstream" tooltip="sstream"]
"52" [label="stdexcept" tooltip="stdexcept"]
"3" [label="string" tooltip="string"]
"30" [label="time.h" tooltip="time.h"]
"47" [label="tuple" tooltip="tuple"]
"51" [label="unordered_map" tooltip="unordered_map"]
"5" [label="utility" tooltip="utility"]
"4" [label="vector" tooltip="vector"]
"14" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"34" -> "9" [dir=forward tooltip="include"]
"34" -> "33" [dir=forward tooltip="include"]
"34" -> "4" [dir=forward tooltip="include"]
"34" -> "3" [dir=forward tooltip="include"]
"34" -> "27" [dir=forward tooltip="include"]
"34" -> "35" [dir=forward tooltip="include"]
"34" -> "6" [dir=forward tooltip="include"]
"34" -> "26" [dir=forward tooltip="include"]
"34" -> "8" [dir=forward tooltip="include"]
"34" -> "13" [dir=forward tooltip="include"]
"57" -> "32" [dir=forward tooltip="include"]
"57" -> "4" [dir=forward tooltip="include"]
"57" -> "45" [dir=forward tooltip="include"]
"57" -> "14" [dir=forward tooltip="include"]
"60" -> "4" [dir=forward tooltip="include"]
"20" -> "6" [dir=forward tooltip="include"]
"20" -> "4" [dir=forward tooltip="include"]
"20" -> "3" [dir=forward tooltip="include"]
"20" -> "21" [dir=forward tooltip="include"]
"20" -> "22" [dir=forward tooltip="include"]
"53" -> "51" [dir=forward tooltip="include"]
"53" -> "4" [dir=forward tooltip="include"]
"53" -> "26" [dir=forward tooltip="include"]
"50" -> "51" [dir=forward tooltip="include"]
"50" -> "52" [dir=forward tooltip="include"]
"50" -> "40" [dir=forward tooltip="include"]
"50" -> "9" [dir=forward tooltip="include"]
"50" -> "32" [dir=forward tooltip="include"]
"50" -> "33" [dir=forward tooltip="include"]
"50" -> "4" [dir=forward tooltip="include"]
"50" -> "26" [dir=forward tooltip="include"]
"50" -> "3" [dir=forward tooltip="include"]
"50" -> "31" [dir=forward tooltip="include"]
"50" -> "27" [dir=forward tooltip="include"]
"50" -> "13" [dir=forward tooltip="include"]
"50" -> "48" [dir=forward tooltip="include"]
"50" -> "7" [dir=forward tooltip="include"]
"50" -> "49" [dir=forward tooltip="include"]
"50" -> "53" [dir=forward tooltip="include"]
"50" -> "54" [dir=forward tooltip="include"]
"50" -> "55" [dir=forward tooltip="include"]
"44" -> "39" [dir=forward tooltip="include"]
"44" -> "45" [dir=forward tooltip="include"]
"44" -> "42" [dir=forward tooltip="include"]
"44" -> "46" [dir=forward tooltip="include"]
"46" -> "9" [dir=forward tooltip="include"]
"46" -> "33" [dir=forward tooltip="include"]
"46" -> "47" [dir=forward tooltip="include"]
"37" -> "35" [dir=forward tooltip="include"]
"37" -> "6" [dir=forward tooltip="include"]
"37" -> "4" [dir=forward tooltip="include"]
"8" -> "9" [dir=forward tooltip="include"]
"8" -> "10" [dir=forward tooltip="include"]
"8" -> "11" [dir=forward tooltip="include"]
"59" -> "3" [dir=forward tooltip="include"]
"59" -> "6" [dir=forward tooltip="include"]
"59" -> "14" [dir=forward tooltip="include"]
"41" -> "42" [dir=forward tooltip="include"]
"49" -> "9" [dir=forward tooltip="include"]
"49" -> "33" [dir=forward tooltip="include"]
"49" -> "21" [dir=forward tooltip="include"]
"49" -> "26" [dir=forward tooltip="include"]
"49" -> "36" [dir=forward tooltip="include"]
"22" -> "23" [dir=forward tooltip="include"]
"22" -> "13" [dir=forward tooltip="include"]
"36" -> "13" [dir=forward tooltip="include"]
"36" -> "9" [dir=forward tooltip="include"]
"36" -> "32" [dir=forward tooltip="include"]
"36" -> "33" [dir=forward tooltip="include"]
"36" -> "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" -> "16" [dir=forward tooltip="include"]
"12" -> "17" [dir=forward tooltip="include"]
"12" -> "18" [dir=forward tooltip="include"]
"12" -> "19" [dir=forward tooltip="include"]
"12" -> "20" [dir=forward tooltip="include"]
"12" -> "24" [dir=forward tooltip="include"]
"12" -> "38" [dir=forward tooltip="include"]
"12" -> "49" [dir=forward tooltip="include"]
"12" -> "36" [dir=forward tooltip="include"]
"12" -> "50" [dir=forward tooltip="include"]
"12" -> "56" [dir=forward tooltip="include"]
"12" -> "57" [dir=forward tooltip="include"]
"12" -> "58" [dir=forward tooltip="include"]
"12" -> "60" [dir=forward tooltip="include"]
"12" -> "8" [dir=forward tooltip="include"]
"12" -> "48" [dir=forward tooltip="include"]
"38" -> "4" [dir=forward tooltip="include"]
"38" -> "6" [dir=forward tooltip="include"]
"38" -> "39" [dir=forward tooltip="include"]
"38" -> "40" [dir=forward tooltip="include"]
"38" -> "41" [dir=forward tooltip="include"]
"38" -> "43" [dir=forward tooltip="include"]
"38" -> "44" [dir=forward tooltip="include"]
"38" -> "48" [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"]
"56" -> "4" [dir=forward tooltip="include"]
"56" -> "26" [dir=forward tooltip="include"]
"56" -> "36" [dir=forward tooltip="include"]
"56" -> "43" [dir=forward tooltip="include"]
"58" -> "10" [dir=forward tooltip="include"]
"58" -> "3" [dir=forward tooltip="include"]
"58" -> "11" [dir=forward tooltip="include"]
"58" -> "27" [dir=forward tooltip="include"]
"58" -> "35" [dir=forward tooltip="include"]
"58" -> "26" [dir=forward tooltip="include"]
"58" -> "14" [dir=forward tooltip="include"]
"58" -> "43" [dir=forward tooltip="include"]
"58" -> "7" [dir=forward tooltip="include"]
"58" -> "59" [dir=forward tooltip="include"]
"58" -> "48" [dir=forward tooltip="include"]
"29" -> "30" [dir=forward tooltip="include"]
"29" -> "31" [dir=forward tooltip="include"]
"29" -> "9" [dir=forward tooltip="include"]
"29" -> "32" [dir=forward tooltip="include"]
"29" -> "33" [dir=forward tooltip="include"]
"24" -> "25" [dir=forward tooltip="include"]
"24" -> "13" [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" -> "34" [dir=forward tooltip="include"]
"24" -> "14" [dir=forward tooltip="include"]
"24" -> "36" [dir=forward tooltip="include"]
"24" -> "22" [dir=forward tooltip="include"]
"24" -> "37" [dir=forward tooltip="include"]
}](_images/graphviz-130995327069b9b1bb9f09e3a453e8bbcdee1026.png)
- file OutHDF5.H
- 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"]
}](_images/graphviz-e099ba209fb7b733921bb7dbb2ff2c10f3f20f24.png)
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"]
}](_images/graphviz-9bd1c0608c1dd9707c6da0e2309971ccf61b999b.png)
- 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"]
}](_images/graphviz-bedcb58aead4e85157e065cd1d7138f041f69239.png)
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"]
}](_images/graphviz-9a29cd9726b105054fbd6a3e0f8e2b12b0c615ae.png)
- 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"]
}](_images/graphviz-f9b9b80ea83918a290f78947704131c1878ab748.png)
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"]
}](_images/graphviz-f5840e375e13b63114d886d4c69beb000b827c1f.png)
- 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"]
}](_images/graphviz-c03a55b873c087046d96c428649e1ce42ce7823e.png)
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"]
}](_images/graphviz-392883a661782831f20f9bfe4e9e84bbdd67c93a.png)
- 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"]
}](_images/graphviz-f9e8cc2909cd8a4ec8ed45a77d30635d163b3bd0.png)
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"]
}](_images/graphviz-f46e7039e933d3cfcfd86a19e99e95ad38d50a85.png)
- 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"]
}](_images/graphviz-7b09a14094454c7aa06ce79c77ed7c2a3080e2c1.png)
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"]
}](_images/graphviz-218f376d1041516a79d411f0f4ba3e474fac5d6c.png)
- 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"]
}](_images/graphviz-1654f9d8e2ba222c17ad78c99332c6304ec02e6a.png)
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"]
}](_images/graphviz-9f565fa1e3f363aaa629ea98907b1c74e020462f.png)
- 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"]
}](_images/graphviz-cca7523c93d3694dc45bf0d2b3a1fae790b27460.png)
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"]
}](_images/graphviz-d3f057af86bb28bf83a2e0477f7eadfe32bb8281.png)
- 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"]
}](_images/graphviz-087b3e7c0c0686770c385cac2ee46739530d1f7a.png)
- 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"]
}](_images/graphviz-1c317679b51b44e916aef2d3396852dd6fd1eaf8.png)
- 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"]
"69" [label="BasisFactory.H" tooltip="BasisFactory.H"]
"65" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"64" [label="Coefficients.H" tooltip="Coefficients.H"]
"66" [label="FieldBasis.H" tooltip="FieldBasis.H"]
"36" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"60" [label="CenterFile.H" tooltip="CenterFile.H"]
"63" [label="Circular.H" tooltip="Circular.H"]
"20" [label="EXPException.H" tooltip="EXPException.H"]
"13" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
"67" [label="OrthoFunction.H" tooltip="OrthoFunction.H"]
"56" [label="Particle.H" tooltip="Particle.H"]
"52" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"46" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"48" [label="QuadLS.H" tooltip="QuadLS.H"]
"41" [label="Species.H" tooltip="Species.H"]
"55" [label="StringTok.H" tooltip="StringTok.H"]
"37" [label="Timer.H" tooltip="Timer.H"]
"62" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"44" [label="euler.H" tooltip="euler.H"]
"70" [label="exputils.H" tooltip="exputils.H"]
"57" [label="gadget.H" tooltip="gadget.H"]
"68" [label="gaussQ.H" tooltip="gaussQ.H"]
"51" [label="header.H" tooltip="header.H"]
"11" [label="interp.H" tooltip="interp.H"]
"23" [label="libvars.H" tooltip="libvars.H"]
"40" [label="localmpi.H" tooltip="localmpi.H"]
"58" [label="tipsy.H" tooltip="tipsy.H"]
"15" [label="Component.H" tooltip="Component.H"]
"42" [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"]
"59" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"61" [label="PotAccel.H" tooltip="PotAccel.H"]
"30" [label="chkTimer.H" tooltip="chkTimer.H"]
"29" [label="coef.H" tooltip="coef.H"]
"25" [label="global.H" tooltip="global.H"]
"5" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"19" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"45" [label="Particle.H" tooltip="Particle.H"]
"43" [label="algorithm" tooltip="algorithm"]
"47" [label="array" tooltip="array"]
"39" [label="chrono" tooltip="chrono"]
"32" [label="cmath" tooltip="cmath"]
"50" [label="config_exp.h" tooltip="config_exp.h"]
"38" [label="cstdlib" tooltip="cstdlib"]
"12" [label="deque" tooltip="deque"]
"34" [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"]
"35" [label="iomanip" tooltip="iomanip"]
"33" [label="iostream" tooltip="iostream"]
"28" [label="list" tooltip="list"]
"14" [label="map" tooltip="map"]
"27" [label="memory" tooltip="memory"]
"16" [label="mpi.h" tooltip="mpi.h"]
"26" [label="pthread.h" tooltip="pthread.h"]
"24" [label="random" tooltip="random"]
"21" [label="set" tooltip="set"]
"22" [label="sstream" tooltip="sstream"]
"54" [label="stdexcept" tooltip="stdexcept"]
"3" [label="string" tooltip="string"]
"31" [label="time.h" tooltip="time.h"]
"49" [label="tuple" tooltip="tuple"]
"53" [label="unordered_map" tooltip="unordered_map"]
"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"]
"69" -> "2" [dir=forward tooltip="include"]
"69" -> "5" [dir=forward tooltip="include"]
"69" -> "6" [dir=forward tooltip="include"]
"69" -> "18" [dir=forward tooltip="include"]
"69" -> "52" [dir=forward tooltip="include"]
"69" -> "67" [dir=forward tooltip="include"]
"69" -> "64" [dir=forward tooltip="include"]
"69" -> "46" [dir=forward tooltip="include"]
"69" -> "62" [dir=forward tooltip="include"]
"69" -> "40" [dir=forward tooltip="include"]
"69" -> "70" [dir=forward tooltip="include"]
"69" -> "11" [dir=forward tooltip="include"]
"65" -> "27" [dir=forward tooltip="include"]
"65" -> "5" [dir=forward tooltip="include"]
"65" -> "6" [dir=forward tooltip="include"]
"64" -> "49" [dir=forward tooltip="include"]
"64" -> "54" [dir=forward tooltip="include"]
"64" -> "7" [dir=forward tooltip="include"]
"64" -> "5" [dir=forward tooltip="include"]
"64" -> "6" [dir=forward tooltip="include"]
"64" -> "18" [dir=forward tooltip="include"]
"64" -> "65" [dir=forward tooltip="include"]
"66" -> "2" [dir=forward tooltip="include"]
"66" -> "5" [dir=forward tooltip="include"]
"66" -> "6" [dir=forward tooltip="include"]
"66" -> "18" [dir=forward tooltip="include"]
"66" -> "52" [dir=forward tooltip="include"]
"66" -> "67" [dir=forward tooltip="include"]
"66" -> "64" [dir=forward tooltip="include"]
"66" -> "62" [dir=forward tooltip="include"]
"66" -> "40" [dir=forward tooltip="include"]
"66" -> "11" [dir=forward tooltip="include"]
"66" -> "69" [dir=forward tooltip="include"]
"36" -> "33" [dir=forward tooltip="include"]
"36" -> "35" [dir=forward tooltip="include"]
"36" -> "4" [dir=forward tooltip="include"]
"36" -> "3" [dir=forward tooltip="include"]
"36" -> "28" [dir=forward tooltip="include"]
"36" -> "14" [dir=forward tooltip="include"]
"36" -> "21" [dir=forward tooltip="include"]
"36" -> "27" [dir=forward tooltip="include"]
"36" -> "37" [dir=forward tooltip="include"]
"36" -> "16" [dir=forward tooltip="include"]
"60" -> "34" [dir=forward tooltip="include"]
"60" -> "4" [dir=forward tooltip="include"]
"60" -> "47" [dir=forward tooltip="include"]
"60" -> "18" [dir=forward tooltip="include"]
"63" -> "4" [dir=forward tooltip="include"]
"20" -> "21" [dir=forward tooltip="include"]
"20" -> "4" [dir=forward tooltip="include"]
"20" -> "3" [dir=forward tooltip="include"]
"20" -> "22" [dir=forward tooltip="include"]
"20" -> "23" [dir=forward tooltip="include"]
"13" -> "4" [dir=forward tooltip="include"]
"13" -> "14" [dir=forward tooltip="include"]
"13" -> "3" [dir=forward tooltip="include"]
"67" -> "2" [dir=forward tooltip="include"]
"67" -> "27" [dir=forward tooltip="include"]
"67" -> "5" [dir=forward tooltip="include"]
"67" -> "68" [dir=forward tooltip="include"]
"56" -> "53" [dir=forward tooltip="include"]
"56" -> "4" [dir=forward tooltip="include"]
"56" -> "27" [dir=forward tooltip="include"]
"52" -> "53" [dir=forward tooltip="include"]
"52" -> "54" [dir=forward tooltip="include"]
"52" -> "43" [dir=forward tooltip="include"]
"52" -> "33" [dir=forward tooltip="include"]
"52" -> "34" [dir=forward tooltip="include"]
"52" -> "35" [dir=forward tooltip="include"]
"52" -> "4" [dir=forward tooltip="include"]
"52" -> "27" [dir=forward tooltip="include"]
"52" -> "3" [dir=forward tooltip="include"]
"52" -> "32" [dir=forward tooltip="include"]
"52" -> "28" [dir=forward tooltip="include"]
"52" -> "16" [dir=forward tooltip="include"]
"52" -> "50" [dir=forward tooltip="include"]
"52" -> "55" [dir=forward tooltip="include"]
"52" -> "51" [dir=forward tooltip="include"]
"52" -> "56" [dir=forward tooltip="include"]
"52" -> "57" [dir=forward tooltip="include"]
"52" -> "58" [dir=forward tooltip="include"]
"46" -> "12" [dir=forward tooltip="include"]
"46" -> "47" [dir=forward tooltip="include"]
"46" -> "5" [dir=forward tooltip="include"]
"46" -> "48" [dir=forward tooltip="include"]
"48" -> "33" [dir=forward tooltip="include"]
"48" -> "35" [dir=forward tooltip="include"]
"48" -> "49" [dir=forward tooltip="include"]
"41" -> "14" [dir=forward tooltip="include"]
"41" -> "21" [dir=forward tooltip="include"]
"41" -> "4" [dir=forward tooltip="include"]
"37" -> "33" [dir=forward tooltip="include"]
"37" -> "38" [dir=forward tooltip="include"]
"37" -> "39" [dir=forward tooltip="include"]
"62" -> "3" [dir=forward tooltip="include"]
"62" -> "21" [dir=forward tooltip="include"]
"62" -> "18" [dir=forward tooltip="include"]
"44" -> "5" [dir=forward tooltip="include"]
"70" -> "3" [dir=forward tooltip="include"]
"70" -> "5" [dir=forward tooltip="include"]
"68" -> "33" [dir=forward tooltip="include"]
"68" -> "35" [dir=forward tooltip="include"]
"68" -> "22" [dir=forward tooltip="include"]
"68" -> "38" [dir=forward tooltip="include"]
"68" -> "3" [dir=forward tooltip="include"]
"68" -> "4" [dir=forward tooltip="include"]
"51" -> "33" [dir=forward tooltip="include"]
"51" -> "35" [dir=forward tooltip="include"]
"51" -> "22" [dir=forward tooltip="include"]
"51" -> "27" [dir=forward tooltip="include"]
"51" -> "40" [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"]
"23" -> "24" [dir=forward tooltip="include"]
"23" -> "16" [dir=forward tooltip="include"]
"40" -> "16" [dir=forward tooltip="include"]
"40" -> "33" [dir=forward tooltip="include"]
"40" -> "34" [dir=forward tooltip="include"]
"40" -> "35" [dir=forward tooltip="include"]
"40" -> "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" -> "7" [dir=forward tooltip="include"]
"15" -> "8" [dir=forward tooltip="include"]
"15" -> "9" [dir=forward tooltip="include"]
"15" -> "10" [dir=forward tooltip="include"]
"15" -> "20" [dir=forward tooltip="include"]
"15" -> "25" [dir=forward tooltip="include"]
"15" -> "42" [dir=forward tooltip="include"]
"15" -> "51" [dir=forward tooltip="include"]
"15" -> "40" [dir=forward tooltip="include"]
"15" -> "52" [dir=forward tooltip="include"]
"15" -> "59" [dir=forward tooltip="include"]
"15" -> "60" [dir=forward tooltip="include"]
"15" -> "61" [dir=forward tooltip="include"]
"15" -> "63" [dir=forward tooltip="include"]
"15" -> "37" [dir=forward tooltip="include"]
"15" -> "50" [dir=forward tooltip="include"]
"42" -> "4" [dir=forward tooltip="include"]
"42" -> "21" [dir=forward tooltip="include"]
"42" -> "12" [dir=forward tooltip="include"]
"42" -> "43" [dir=forward tooltip="include"]
"42" -> "44" [dir=forward tooltip="include"]
"42" -> "45" [dir=forward tooltip="include"]
"42" -> "46" [dir=forward tooltip="include"]
"42" -> "50" [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" -> "20" [dir=forward tooltip="include"]
"1" -> "64" [dir=forward tooltip="include"]
"1" -> "66" [dir=forward tooltip="include"]
"59" -> "4" [dir=forward tooltip="include"]
"59" -> "27" [dir=forward tooltip="include"]
"59" -> "40" [dir=forward tooltip="include"]
"59" -> "45" [dir=forward tooltip="include"]
"61" -> "38" [dir=forward tooltip="include"]
"61" -> "3" [dir=forward tooltip="include"]
"61" -> "39" [dir=forward tooltip="include"]
"61" -> "28" [dir=forward tooltip="include"]
"61" -> "14" [dir=forward tooltip="include"]
"61" -> "27" [dir=forward tooltip="include"]
"61" -> "18" [dir=forward tooltip="include"]
"61" -> "45" [dir=forward tooltip="include"]
"61" -> "55" [dir=forward tooltip="include"]
"61" -> "62" [dir=forward tooltip="include"]
"61" -> "50" [dir=forward tooltip="include"]
"30" -> "31" [dir=forward tooltip="include"]
"30" -> "32" [dir=forward tooltip="include"]
"30" -> "33" [dir=forward tooltip="include"]
"30" -> "34" [dir=forward tooltip="include"]
"30" -> "35" [dir=forward tooltip="include"]
"25" -> "26" [dir=forward tooltip="include"]
"25" -> "16" [dir=forward tooltip="include"]
"25" -> "4" [dir=forward tooltip="include"]
"25" -> "3" [dir=forward tooltip="include"]
"25" -> "27" [dir=forward tooltip="include"]
"25" -> "24" [dir=forward tooltip="include"]
"25" -> "28" [dir=forward tooltip="include"]
"25" -> "29" [dir=forward tooltip="include"]
"25" -> "30" [dir=forward tooltip="include"]
"25" -> "36" [dir=forward tooltip="include"]
"25" -> "18" [dir=forward tooltip="include"]
"25" -> "40" [dir=forward tooltip="include"]
"25" -> "23" [dir=forward tooltip="include"]
"25" -> "41" [dir=forward tooltip="include"]
}](_images/graphviz-75c9394c17a2a36be7b895a207894fd1fa51e871.png)
- 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"]
}](_images/graphviz-2a5191a8139cc7e22e0da462a1d17802c1b4cbbe.png)
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"]
}](_images/graphviz-3f48cb1746e0a82c5d645839dd189c97d812f77b.png)
Typedefs
-
typedef std::shared_ptr<ParticleFerry> ParticleFerryPtr
-
typedef std::shared_ptr<ParticleFerry> ParticleFerryPtr
- file PeriodicBC.H
- #include <random>#include <Particle.H>#include <AxisymmetricBasis.H>#include <ExternalCollection.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"]
"42" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"62" [label="CenterFile.H" tooltip="CenterFile.H"]
"63" [label="Circular.H" tooltip="Circular.H"]
"29" [label="EXPException.H" tooltip="EXPException.H"]
"58" [label="Particle.H" tooltip="Particle.H"]
"55" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"50" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"52" [label="QuadLS.H" tooltip="QuadLS.H"]
"45" [label="Species.H" tooltip="Species.H"]
"14" [label="StringTok.H" tooltip="StringTok.H"]
"43" [label="Timer.H" tooltip="Timer.H"]
"15" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"49" [label="euler.H" tooltip="euler.H"]
"59" [label="gadget.H" tooltip="gadget.H"]
"54" [label="header.H" tooltip="header.H"]
"32" [label="libvars.H" tooltip="libvars.H"]
"44" [label="localmpi.H" tooltip="localmpi.H"]
"60" [label="tipsy.H" tooltip="tipsy.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"]
"64" [label="ExternalForce.H" tooltip="ExternalForce.H"]
"46" [label="Orient.H" tooltip="Orient.H"]
"61" [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"]
"36" [label="chkTimer.H" tooltip="chkTimer.H"]
"35" [label="coef.H" tooltip="coef.H"]
"33" [label="global.H" tooltip="global.H"]
"18" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"24" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"3" [label="Particle.H" tooltip="Particle.H"]
"48" [label="algorithm" tooltip="algorithm"]
"51" [label="array" tooltip="array"]
"9" [label="chrono" tooltip="chrono"]
"38" [label="cmath" tooltip="cmath"]
"17" [label="config_exp.h" tooltip="config_exp.h"]
"7" [label="cstdlib" tooltip="cstdlib"]
"47" [label="deque" tooltip="deque"]
"40" [label="fstream" tooltip="fstream"]
"28" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"26" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"27" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"25" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"41" [label="iomanip" tooltip="iomanip"]
"39" [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"]
"34" [label="pthread.h" tooltip="pthread.h"]
"2" [label="random" tooltip="random"]
"16" [label="set" tooltip="set"]
"31" [label="sstream" tooltip="sstream"]
"57" [label="stdexcept" tooltip="stdexcept"]
"8" [label="string" tooltip="string"]
"37" [label="time.h" tooltip="time.h"]
"53" [label="tuple" tooltip="tuple"]
"56" [label="unordered_map" tooltip="unordered_map"]
"23" [label="utility" tooltip="utility"]
"30" [label="vector" tooltip="vector"]
"13" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"42" -> "39" [dir=forward tooltip="include"]
"42" -> "41" [dir=forward tooltip="include"]
"42" -> "30" [dir=forward tooltip="include"]
"42" -> "8" [dir=forward tooltip="include"]
"42" -> "10" [dir=forward tooltip="include"]
"42" -> "11" [dir=forward tooltip="include"]
"42" -> "16" [dir=forward tooltip="include"]
"42" -> "12" [dir=forward tooltip="include"]
"42" -> "43" [dir=forward tooltip="include"]
"42" -> "22" [dir=forward tooltip="include"]
"62" -> "40" [dir=forward tooltip="include"]
"62" -> "30" [dir=forward tooltip="include"]
"62" -> "51" [dir=forward tooltip="include"]
"62" -> "13" [dir=forward tooltip="include"]
"63" -> "30" [dir=forward tooltip="include"]
"29" -> "16" [dir=forward tooltip="include"]
"29" -> "30" [dir=forward tooltip="include"]
"29" -> "8" [dir=forward tooltip="include"]
"29" -> "31" [dir=forward tooltip="include"]
"29" -> "32" [dir=forward tooltip="include"]
"58" -> "56" [dir=forward tooltip="include"]
"58" -> "30" [dir=forward tooltip="include"]
"58" -> "12" [dir=forward tooltip="include"]
"55" -> "56" [dir=forward tooltip="include"]
"55" -> "57" [dir=forward tooltip="include"]
"55" -> "48" [dir=forward tooltip="include"]
"55" -> "39" [dir=forward tooltip="include"]
"55" -> "40" [dir=forward tooltip="include"]
"55" -> "41" [dir=forward tooltip="include"]
"55" -> "30" [dir=forward tooltip="include"]
"55" -> "12" [dir=forward tooltip="include"]
"55" -> "8" [dir=forward tooltip="include"]
"55" -> "38" [dir=forward tooltip="include"]
"55" -> "10" [dir=forward tooltip="include"]
"55" -> "22" [dir=forward tooltip="include"]
"55" -> "17" [dir=forward tooltip="include"]
"55" -> "14" [dir=forward tooltip="include"]
"55" -> "54" [dir=forward tooltip="include"]
"55" -> "58" [dir=forward tooltip="include"]
"55" -> "59" [dir=forward tooltip="include"]
"55" -> "60" [dir=forward tooltip="include"]
"50" -> "47" [dir=forward tooltip="include"]
"50" -> "51" [dir=forward tooltip="include"]
"50" -> "18" [dir=forward tooltip="include"]
"50" -> "52" [dir=forward tooltip="include"]
"52" -> "39" [dir=forward tooltip="include"]
"52" -> "41" [dir=forward tooltip="include"]
"52" -> "53" [dir=forward tooltip="include"]
"45" -> "11" [dir=forward tooltip="include"]
"45" -> "16" [dir=forward tooltip="include"]
"45" -> "30" [dir=forward tooltip="include"]
"43" -> "39" [dir=forward tooltip="include"]
"43" -> "7" [dir=forward tooltip="include"]
"43" -> "9" [dir=forward tooltip="include"]
"15" -> "8" [dir=forward tooltip="include"]
"15" -> "16" [dir=forward tooltip="include"]
"15" -> "13" [dir=forward tooltip="include"]
"49" -> "18" [dir=forward tooltip="include"]
"54" -> "39" [dir=forward tooltip="include"]
"54" -> "41" [dir=forward tooltip="include"]
"54" -> "31" [dir=forward tooltip="include"]
"54" -> "12" [dir=forward tooltip="include"]
"54" -> "44" [dir=forward tooltip="include"]
"32" -> "2" [dir=forward tooltip="include"]
"32" -> "22" [dir=forward tooltip="include"]
"44" -> "22" [dir=forward tooltip="include"]
"44" -> "39" [dir=forward tooltip="include"]
"44" -> "40" [dir=forward tooltip="include"]
"44" -> "41" [dir=forward tooltip="include"]
"44" -> "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" -> "25" [dir=forward tooltip="include"]
"21" -> "26" [dir=forward tooltip="include"]
"21" -> "27" [dir=forward tooltip="include"]
"21" -> "28" [dir=forward tooltip="include"]
"21" -> "29" [dir=forward tooltip="include"]
"21" -> "33" [dir=forward tooltip="include"]
"21" -> "46" [dir=forward tooltip="include"]
"21" -> "54" [dir=forward tooltip="include"]
"21" -> "44" [dir=forward tooltip="include"]
"21" -> "55" [dir=forward tooltip="include"]
"21" -> "61" [dir=forward tooltip="include"]
"21" -> "62" [dir=forward tooltip="include"]
"21" -> "6" [dir=forward tooltip="include"]
"21" -> "63" [dir=forward tooltip="include"]
"21" -> "43" [dir=forward tooltip="include"]
"21" -> "17" [dir=forward tooltip="include"]
"20" -> "10" [dir=forward tooltip="include"]
"20" -> "21" [dir=forward tooltip="include"]
"20" -> "43" [dir=forward tooltip="include"]
"19" -> "11" [dir=forward tooltip="include"]
"19" -> "20" [dir=forward tooltip="include"]
"19" -> "64" [dir=forward tooltip="include"]
"64" -> "6" [dir=forward tooltip="include"]
"64" -> "21" [dir=forward tooltip="include"]
"46" -> "30" [dir=forward tooltip="include"]
"46" -> "16" [dir=forward tooltip="include"]
"46" -> "47" [dir=forward tooltip="include"]
"46" -> "48" [dir=forward tooltip="include"]
"46" -> "49" [dir=forward tooltip="include"]
"46" -> "3" [dir=forward tooltip="include"]
"46" -> "50" [dir=forward tooltip="include"]
"46" -> "17" [dir=forward tooltip="include"]
"61" -> "30" [dir=forward tooltip="include"]
"61" -> "12" [dir=forward tooltip="include"]
"61" -> "44" [dir=forward tooltip="include"]
"61" -> "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"]
"36" -> "37" [dir=forward tooltip="include"]
"36" -> "38" [dir=forward tooltip="include"]
"36" -> "39" [dir=forward tooltip="include"]
"36" -> "40" [dir=forward tooltip="include"]
"36" -> "41" [dir=forward tooltip="include"]
"33" -> "34" [dir=forward tooltip="include"]
"33" -> "22" [dir=forward tooltip="include"]
"33" -> "30" [dir=forward tooltip="include"]
"33" -> "8" [dir=forward tooltip="include"]
"33" -> "12" [dir=forward tooltip="include"]
"33" -> "2" [dir=forward tooltip="include"]
"33" -> "10" [dir=forward tooltip="include"]
"33" -> "35" [dir=forward tooltip="include"]
"33" -> "36" [dir=forward tooltip="include"]
"33" -> "42" [dir=forward tooltip="include"]
"33" -> "13" [dir=forward tooltip="include"]
"33" -> "44" [dir=forward tooltip="include"]
"33" -> "32" [dir=forward tooltip="include"]
"33" -> "45" [dir=forward tooltip="include"]
}](_images/graphviz-741b4b1d7e4f3e50100b1d61f45bcfdd3e113791.png)
- file PolarBasis.H
- #include <memory>#include <random>#include <vector>#include <string>#include <set>#include <AxisymmetricBasis.H>#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"]
"27" [label="CoefContainer.H" tooltip="CoefContainer.H"]
"25" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"20" [label="Coefficients.H" tooltip="Coefficients.H"]
"29" [label="BiorthCyl.H" tooltip="BiorthCyl.H"]
"45" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
"53" [label="EXPmath.H" tooltip="EXPmath.H"]
"49" [label="EmpCyl2d.H" tooltip="EmpCyl2d.H"]
"39" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
"44" [label="QPDistF.H" tooltip="QPDistF.H"]
"16" [label="StringTok.H" tooltip="StringTok.H"]
"17" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"42" [label="gaussQ.H" tooltip="gaussQ.H"]
"37" [label="interp.H" tooltip="interp.H"]
"34" [label="localmpi.H" tooltip="localmpi.H"]
"36" [label="massmodel.H" tooltip="massmodel.H"]
"40" [label="orbit.H" tooltip="orbit.H"]
"7" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
"8" [label="Basis.H" tooltip="Basis.H"]
"26" [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"]
"28" [label="Eigen/Dense" tooltip="Eigen/Dense"]
"19" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"52" [label="Eigen/Eigenvalues" tooltip="Eigen/Eigenvalues"]
"15" [label="Particle.H" tooltip="Particle.H"]
"50" [label="algorithm" tooltip="algorithm"]
"51" [label="array" tooltip="array"]
"11" [label="chrono" tooltip="chrono"]
"32" [label="cmath" tooltip="cmath"]
"18" [label="config_exp.h" tooltip="config_exp.h"]
"10" [label="cstdlib" tooltip="cstdlib"]
"38" [label="deque" tooltip="deque"]
"31" [label="fstream" tooltip="fstream"]
"41" [label="functional" tooltip="functional"]
"48" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"46" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"47" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"23" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"55" [label="highfive/eigen.hpp" tooltip="highfive/eigen.hpp"]
"54" [label="highfive/highfive.hpp" tooltip="highfive/highfive.hpp"]
"35" [label="iomanip" tooltip="iomanip"]
"30" [label="iostream" tooltip="iostream"]
"12" [label="list" tooltip="list"]
"13" [label="map" tooltip="map"]
"2" [label="memory" tooltip="memory"]
"33" [label="mpi.h" tooltip="mpi.h"]
"3" [label="random" tooltip="random"]
"6" [label="set" tooltip="set"]
"43" [label="sstream" tooltip="sstream"]
"22" [label="stdexcept" tooltip="stdexcept"]
"5" [label="string" tooltip="string"]
"21" [label="tuple" tooltip="tuple"]
"24" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"4" [label="vector" tooltip="vector"]
"14" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"27" -> "2" [dir=forward tooltip="include"]
"27" -> "21" [dir=forward tooltip="include"]
"27" -> "13" [dir=forward tooltip="include"]
"27" -> "6" [dir=forward tooltip="include"]
"27" -> "28" [dir=forward tooltip="include"]
"27" -> "20" [dir=forward tooltip="include"]
"25" -> "2" [dir=forward tooltip="include"]
"25" -> "19" [dir=forward tooltip="include"]
"25" -> "24" [dir=forward tooltip="include"]
"20" -> "21" [dir=forward tooltip="include"]
"20" -> "22" [dir=forward tooltip="include"]
"20" -> "23" [dir=forward tooltip="include"]
"20" -> "19" [dir=forward tooltip="include"]
"20" -> "24" [dir=forward tooltip="include"]
"20" -> "14" [dir=forward tooltip="include"]
"20" -> "25" [dir=forward tooltip="include"]
"29" -> "30" [dir=forward tooltip="include"]
"29" -> "31" [dir=forward tooltip="include"]
"29" -> "5" [dir=forward tooltip="include"]
"29" -> "32" [dir=forward tooltip="include"]
"29" -> "19" [dir=forward tooltip="include"]
"29" -> "33" [dir=forward tooltip="include"]
"29" -> "34" [dir=forward tooltip="include"]
"29" -> "18" [dir=forward tooltip="include"]
"29" -> "36" [dir=forward tooltip="include"]
"29" -> "14" [dir=forward tooltip="include"]
"29" -> "23" [dir=forward tooltip="include"]
"29" -> "46" [dir=forward tooltip="include"]
"29" -> "47" [dir=forward tooltip="include"]
"29" -> "48" [dir=forward tooltip="include"]
"29" -> "49" [dir=forward tooltip="include"]
"45" -> "36" [dir=forward tooltip="include"]
"49" -> "50" [dir=forward tooltip="include"]
"49" -> "2" [dir=forward tooltip="include"]
"49" -> "5" [dir=forward tooltip="include"]
"49" -> "4" [dir=forward tooltip="include"]
"49" -> "51" [dir=forward tooltip="include"]
"49" -> "21" [dir=forward tooltip="include"]
"49" -> "19" [dir=forward tooltip="include"]
"49" -> "52" [dir=forward tooltip="include"]
"49" -> "14" [dir=forward tooltip="include"]
"49" -> "18" [dir=forward tooltip="include"]
"49" -> "42" [dir=forward tooltip="include"]
"49" -> "53" [dir=forward tooltip="include"]
"49" -> "34" [dir=forward tooltip="include"]
"49" -> "54" [dir=forward tooltip="include"]
"49" -> "55" [dir=forward tooltip="include"]
"39" -> "4" [dir=forward tooltip="include"]
"39" -> "13" [dir=forward tooltip="include"]
"39" -> "5" [dir=forward tooltip="include"]
"44" -> "35" [dir=forward tooltip="include"]
"44" -> "5" [dir=forward tooltip="include"]
"44" -> "13" [dir=forward tooltip="include"]
"44" -> "36" [dir=forward tooltip="include"]
"44" -> "45" [dir=forward tooltip="include"]
"44" -> "40" [dir=forward tooltip="include"]
"17" -> "5" [dir=forward tooltip="include"]
"17" -> "6" [dir=forward tooltip="include"]
"17" -> "14" [dir=forward tooltip="include"]
"42" -> "30" [dir=forward tooltip="include"]
"42" -> "35" [dir=forward tooltip="include"]
"42" -> "43" [dir=forward tooltip="include"]
"42" -> "10" [dir=forward tooltip="include"]
"42" -> "5" [dir=forward tooltip="include"]
"42" -> "4" [dir=forward tooltip="include"]
"37" -> "19" [dir=forward tooltip="include"]
"37" -> "4" [dir=forward tooltip="include"]
"37" -> "38" [dir=forward tooltip="include"]
"37" -> "39" [dir=forward tooltip="include"]
"34" -> "33" [dir=forward tooltip="include"]
"34" -> "30" [dir=forward tooltip="include"]
"34" -> "31" [dir=forward tooltip="include"]
"34" -> "35" [dir=forward tooltip="include"]
"34" -> "5" [dir=forward tooltip="include"]
"36" -> "4" [dir=forward tooltip="include"]
"36" -> "2" [dir=forward tooltip="include"]
"36" -> "3" [dir=forward tooltip="include"]
"36" -> "21" [dir=forward tooltip="include"]
"36" -> "19" [dir=forward tooltip="include"]
"36" -> "37" [dir=forward tooltip="include"]
"36" -> "40" [dir=forward tooltip="include"]
"36" -> "44" [dir=forward tooltip="include"]
"40" -> "41" [dir=forward tooltip="include"]
"40" -> "2" [dir=forward tooltip="include"]
"40" -> "19" [dir=forward tooltip="include"]
"40" -> "42" [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"]
"26" -> "2" [dir=forward tooltip="include"]
"26" -> "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" -> "26" [dir=forward tooltip="include"]
"1" -> "27" [dir=forward tooltip="include"]
"1" -> "29" [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"]
}](_images/graphviz-0d90eadfb370f45ed21451813fb5f83f7d2b34c9.png)
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"]
}](_images/graphviz-a1cad1373e17414db7ab241127441b125ee1ffe4.png)
- 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"]
}](_images/graphviz-0dd10e7e81410e30b08ccff558a1361362016739.png)
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"]
}](_images/graphviz-6f87dd53128016e5c5f5e6675bc4290478562a1d.png)
- 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"]
"38" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"59" [label="CenterFile.H" tooltip="CenterFile.H"]
"60" [label="Circular.H" tooltip="Circular.H"]
"25" [label="EXPException.H" tooltip="EXPException.H"]
"55" [label="Particle.H" tooltip="Particle.H"]
"52" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"47" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"49" [label="QuadLS.H" tooltip="QuadLS.H"]
"41" [label="Species.H" tooltip="Species.H"]
"14" [label="StringTok.H" tooltip="StringTok.H"]
"39" [label="Timer.H" tooltip="Timer.H"]
"15" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"45" [label="euler.H" tooltip="euler.H"]
"56" [label="gadget.H" tooltip="gadget.H"]
"51" [label="header.H" tooltip="header.H"]
"28" [label="libvars.H" tooltip="libvars.H"]
"40" [label="localmpi.H" tooltip="localmpi.H"]
"57" [label="tipsy.H" tooltip="tipsy.H"]
"18" [label="Component.H" tooltip="Component.H"]
"4" [label="ExternalForce.H" tooltip="ExternalForce.H"]
"42" [label="Orient.H" tooltip="Orient.H"]
"58" [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"]
"32" [label="chkTimer.H" tooltip="chkTimer.H"]
"31" [label="coef.H" tooltip="coef.H"]
"29" [label="global.H" tooltip="global.H"]
"46" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"20" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"13" [label="Particle.H" tooltip="Particle.H"]
"44" [label="algorithm" tooltip="algorithm"]
"48" [label="array" tooltip="array"]
"8" [label="chrono" tooltip="chrono"]
"34" [label="cmath" tooltip="cmath"]
"17" [label="config_exp.h" tooltip="config_exp.h"]
"6" [label="cstdlib" tooltip="cstdlib"]
"43" [label="deque" tooltip="deque"]
"36" [label="fstream" tooltip="fstream"]
"24" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"22" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"23" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"21" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"37" [label="iomanip" tooltip="iomanip"]
"35" [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"]
"30" [label="pthread.h" tooltip="pthread.h"]
"3" [label="random" tooltip="random"]
"16" [label="set" tooltip="set"]
"27" [label="sstream" tooltip="sstream"]
"54" [label="stdexcept" tooltip="stdexcept"]
"7" [label="string" tooltip="string"]
"33" [label="time.h" tooltip="time.h"]
"50" [label="tuple" tooltip="tuple"]
"53" [label="unordered_map" tooltip="unordered_map"]
"2" [label="utility" tooltip="utility"]
"26" [label="vector" tooltip="vector"]
"12" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"38" -> "35" [dir=forward tooltip="include"]
"38" -> "37" [dir=forward tooltip="include"]
"38" -> "26" [dir=forward tooltip="include"]
"38" -> "7" [dir=forward tooltip="include"]
"38" -> "9" [dir=forward tooltip="include"]
"38" -> "10" [dir=forward tooltip="include"]
"38" -> "16" [dir=forward tooltip="include"]
"38" -> "11" [dir=forward tooltip="include"]
"38" -> "39" [dir=forward tooltip="include"]
"38" -> "19" [dir=forward tooltip="include"]
"59" -> "36" [dir=forward tooltip="include"]
"59" -> "26" [dir=forward tooltip="include"]
"59" -> "48" [dir=forward tooltip="include"]
"59" -> "12" [dir=forward tooltip="include"]
"60" -> "26" [dir=forward tooltip="include"]
"25" -> "16" [dir=forward tooltip="include"]
"25" -> "26" [dir=forward tooltip="include"]
"25" -> "7" [dir=forward tooltip="include"]
"25" -> "27" [dir=forward tooltip="include"]
"25" -> "28" [dir=forward tooltip="include"]
"55" -> "53" [dir=forward tooltip="include"]
"55" -> "26" [dir=forward tooltip="include"]
"55" -> "11" [dir=forward tooltip="include"]
"52" -> "53" [dir=forward tooltip="include"]
"52" -> "54" [dir=forward tooltip="include"]
"52" -> "44" [dir=forward tooltip="include"]
"52" -> "35" [dir=forward tooltip="include"]
"52" -> "36" [dir=forward tooltip="include"]
"52" -> "37" [dir=forward tooltip="include"]
"52" -> "26" [dir=forward tooltip="include"]
"52" -> "11" [dir=forward tooltip="include"]
"52" -> "7" [dir=forward tooltip="include"]
"52" -> "34" [dir=forward tooltip="include"]
"52" -> "9" [dir=forward tooltip="include"]
"52" -> "19" [dir=forward tooltip="include"]
"52" -> "17" [dir=forward tooltip="include"]
"52" -> "14" [dir=forward tooltip="include"]
"52" -> "51" [dir=forward tooltip="include"]
"52" -> "55" [dir=forward tooltip="include"]
"52" -> "56" [dir=forward tooltip="include"]
"52" -> "57" [dir=forward tooltip="include"]
"47" -> "43" [dir=forward tooltip="include"]
"47" -> "48" [dir=forward tooltip="include"]
"47" -> "46" [dir=forward tooltip="include"]
"47" -> "49" [dir=forward tooltip="include"]
"49" -> "35" [dir=forward tooltip="include"]
"49" -> "37" [dir=forward tooltip="include"]
"49" -> "50" [dir=forward tooltip="include"]
"41" -> "10" [dir=forward tooltip="include"]
"41" -> "16" [dir=forward tooltip="include"]
"41" -> "26" [dir=forward tooltip="include"]
"39" -> "35" [dir=forward tooltip="include"]
"39" -> "6" [dir=forward tooltip="include"]
"39" -> "8" [dir=forward tooltip="include"]
"15" -> "7" [dir=forward tooltip="include"]
"15" -> "16" [dir=forward tooltip="include"]
"15" -> "12" [dir=forward tooltip="include"]
"45" -> "46" [dir=forward tooltip="include"]
"51" -> "35" [dir=forward tooltip="include"]
"51" -> "37" [dir=forward tooltip="include"]
"51" -> "27" [dir=forward tooltip="include"]
"51" -> "11" [dir=forward tooltip="include"]
"51" -> "40" [dir=forward tooltip="include"]
"28" -> "3" [dir=forward tooltip="include"]
"28" -> "19" [dir=forward tooltip="include"]
"40" -> "19" [dir=forward tooltip="include"]
"40" -> "35" [dir=forward tooltip="include"]
"40" -> "36" [dir=forward tooltip="include"]
"40" -> "37" [dir=forward tooltip="include"]
"40" -> "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" -> "21" [dir=forward tooltip="include"]
"18" -> "22" [dir=forward tooltip="include"]
"18" -> "23" [dir=forward tooltip="include"]
"18" -> "24" [dir=forward tooltip="include"]
"18" -> "25" [dir=forward tooltip="include"]
"18" -> "29" [dir=forward tooltip="include"]
"18" -> "42" [dir=forward tooltip="include"]
"18" -> "51" [dir=forward tooltip="include"]
"18" -> "40" [dir=forward tooltip="include"]
"18" -> "52" [dir=forward tooltip="include"]
"18" -> "58" [dir=forward tooltip="include"]
"18" -> "59" [dir=forward tooltip="include"]
"18" -> "5" [dir=forward tooltip="include"]
"18" -> "60" [dir=forward tooltip="include"]
"18" -> "39" [dir=forward tooltip="include"]
"18" -> "17" [dir=forward tooltip="include"]
"4" -> "5" [dir=forward tooltip="include"]
"4" -> "18" [dir=forward tooltip="include"]
"42" -> "26" [dir=forward tooltip="include"]
"42" -> "16" [dir=forward tooltip="include"]
"42" -> "43" [dir=forward tooltip="include"]
"42" -> "44" [dir=forward tooltip="include"]
"42" -> "45" [dir=forward tooltip="include"]
"42" -> "13" [dir=forward tooltip="include"]
"42" -> "47" [dir=forward tooltip="include"]
"42" -> "17" [dir=forward tooltip="include"]
"58" -> "26" [dir=forward tooltip="include"]
"58" -> "11" [dir=forward tooltip="include"]
"58" -> "40" [dir=forward tooltip="include"]
"58" -> "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"]
"32" -> "33" [dir=forward tooltip="include"]
"32" -> "34" [dir=forward tooltip="include"]
"32" -> "35" [dir=forward tooltip="include"]
"32" -> "36" [dir=forward tooltip="include"]
"32" -> "37" [dir=forward tooltip="include"]
"29" -> "30" [dir=forward tooltip="include"]
"29" -> "19" [dir=forward tooltip="include"]
"29" -> "26" [dir=forward tooltip="include"]
"29" -> "7" [dir=forward tooltip="include"]
"29" -> "11" [dir=forward tooltip="include"]
"29" -> "3" [dir=forward tooltip="include"]
"29" -> "9" [dir=forward tooltip="include"]
"29" -> "31" [dir=forward tooltip="include"]
"29" -> "32" [dir=forward tooltip="include"]
"29" -> "38" [dir=forward tooltip="include"]
"29" -> "12" [dir=forward tooltip="include"]
"29" -> "40" [dir=forward tooltip="include"]
"29" -> "28" [dir=forward tooltip="include"]
"29" -> "41" [dir=forward tooltip="include"]
}](_images/graphviz-3a2036420b7780b4b5b36a11dc667a760be4e727.png)
Typedefs
-
typedef pair<double, int> rpair
-
typedef pair<double, int> rpair
- file Shells.H
- #include <vector>#include <string>#include <set>#include “expand.H”#include “interp.H”#include <AxisymmetricBasis.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"]
"37" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"60" [label="CenterFile.H" tooltip="CenterFile.H"]
"63" [label="Circular.H" tooltip="Circular.H"]
"75" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
"29" [label="EXPException.H" tooltip="EXPException.H"]
"67" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
"56" [label="Particle.H" tooltip="Particle.H"]
"53" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"48" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"74" [label="QPDistF.H" tooltip="QPDistF.H"]
"50" [label="QuadLS.H" tooltip="QuadLS.H"]
"42" [label="Species.H" tooltip="Species.H"]
"55" [label="StringTok.H" tooltip="StringTok.H"]
"39" [label="Timer.H" tooltip="Timer.H"]
"62" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"46" [label="euler.H" tooltip="euler.H"]
"57" [label="gadget.H" tooltip="gadget.H"]
"73" [label="gaussQ.H" tooltip="gaussQ.H"]
"52" [label="header.H" tooltip="header.H"]
"66" [label="interp.H" tooltip="interp.H"]
"30" [label="libvars.H" tooltip="libvars.H"]
"41" [label="localmpi.H" tooltip="localmpi.H"]
"70" [label="massmodel.H" tooltip="massmodel.H"]
"71" [label="orbit.H" tooltip="orbit.H"]
"58" [label="tipsy.H" tooltip="tipsy.H"]
"68" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
"69" [label="Basis.H" tooltip="Basis.H"]
"21" [label="Component.H" tooltip="Component.H"]
"19" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
"64" [label="ExternalForce.H" tooltip="ExternalForce.H"]
"43" [label="Orient.H" tooltip="Orient.H"]
"65" [label="Output.H" tooltip="Output.H"]
"59" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"61" [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"]
"35" [label="chkTimer.H" tooltip="chkTimer.H"]
"34" [label="coef.H" tooltip="coef.H"]
"5" [label="expand.H" tooltip="expand.H"]
"32" [label="global.H" tooltip="global.H"]
"18" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"24" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"47" [label="Particle.H" tooltip="Particle.H"]
"45" [label="algorithm" tooltip="algorithm"]
"49" [label="array" tooltip="array"]
"40" [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"]
"44" [label="deque" tooltip="deque"]
"14" [label="fstream" tooltip="fstream"]
"72" [label="functional" tooltip="functional"]
"28" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"26" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"27" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"25" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"16" [label="iomanip" tooltip="iomanip"]
"13" [label="iostream" tooltip="iostream"]
"17" [label="limits" tooltip="limits"]
"20" [label="list" tooltip="list"]
"38" [label="map" tooltip="map"]
"33" [label="memory" tooltip="memory"]
"7" [label="mpi.h" tooltip="mpi.h"]
"8" [label="pthread.h" tooltip="pthread.h"]
"31" [label="random" tooltip="random"]
"4" [label="set" tooltip="set"]
"15" [label="sstream" tooltip="sstream"]
"9" [label="stdexcept" tooltip="stdexcept"]
"3" [label="string" tooltip="string"]
"36" [label="time.h" tooltip="time.h"]
"51" [label="tuple" tooltip="tuple"]
"54" [label="unordered_map" tooltip="unordered_map"]
"22" [label="utility" tooltip="utility"]
"2" [label="vector" tooltip="vector"]
"23" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"37" -> "13" [dir=forward tooltip="include"]
"37" -> "16" [dir=forward tooltip="include"]
"37" -> "2" [dir=forward tooltip="include"]
"37" -> "3" [dir=forward tooltip="include"]
"37" -> "20" [dir=forward tooltip="include"]
"37" -> "38" [dir=forward tooltip="include"]
"37" -> "4" [dir=forward tooltip="include"]
"37" -> "33" [dir=forward tooltip="include"]
"37" -> "39" [dir=forward tooltip="include"]
"37" -> "7" [dir=forward tooltip="include"]
"60" -> "14" [dir=forward tooltip="include"]
"60" -> "2" [dir=forward tooltip="include"]
"60" -> "49" [dir=forward tooltip="include"]
"60" -> "23" [dir=forward tooltip="include"]
"63" -> "2" [dir=forward tooltip="include"]
"75" -> "70" [dir=forward tooltip="include"]
"29" -> "4" [dir=forward tooltip="include"]
"29" -> "2" [dir=forward tooltip="include"]
"29" -> "3" [dir=forward tooltip="include"]
"29" -> "15" [dir=forward tooltip="include"]
"29" -> "30" [dir=forward tooltip="include"]
"67" -> "2" [dir=forward tooltip="include"]
"67" -> "38" [dir=forward tooltip="include"]
"67" -> "3" [dir=forward tooltip="include"]
"56" -> "54" [dir=forward tooltip="include"]
"56" -> "2" [dir=forward tooltip="include"]
"56" -> "33" [dir=forward tooltip="include"]
"53" -> "54" [dir=forward tooltip="include"]
"53" -> "9" [dir=forward tooltip="include"]
"53" -> "45" [dir=forward tooltip="include"]
"53" -> "13" [dir=forward tooltip="include"]
"53" -> "14" [dir=forward tooltip="include"]
"53" -> "16" [dir=forward tooltip="include"]
"53" -> "2" [dir=forward tooltip="include"]
"53" -> "33" [dir=forward tooltip="include"]
"53" -> "3" [dir=forward tooltip="include"]
"53" -> "11" [dir=forward tooltip="include"]
"53" -> "20" [dir=forward tooltip="include"]
"53" -> "7" [dir=forward tooltip="include"]
"53" -> "6" [dir=forward tooltip="include"]
"53" -> "55" [dir=forward tooltip="include"]
"53" -> "52" [dir=forward tooltip="include"]
"53" -> "56" [dir=forward tooltip="include"]
"53" -> "57" [dir=forward tooltip="include"]
"53" -> "58" [dir=forward tooltip="include"]
"48" -> "44" [dir=forward tooltip="include"]
"48" -> "49" [dir=forward tooltip="include"]
"48" -> "18" [dir=forward tooltip="include"]
"48" -> "50" [dir=forward tooltip="include"]
"74" -> "16" [dir=forward tooltip="include"]
"74" -> "3" [dir=forward tooltip="include"]
"74" -> "38" [dir=forward tooltip="include"]
"74" -> "70" [dir=forward tooltip="include"]
"74" -> "75" [dir=forward tooltip="include"]
"74" -> "71" [dir=forward tooltip="include"]
"50" -> "13" [dir=forward tooltip="include"]
"50" -> "16" [dir=forward tooltip="include"]
"50" -> "51" [dir=forward tooltip="include"]
"42" -> "38" [dir=forward tooltip="include"]
"42" -> "4" [dir=forward tooltip="include"]
"42" -> "2" [dir=forward tooltip="include"]
"39" -> "13" [dir=forward tooltip="include"]
"39" -> "10" [dir=forward tooltip="include"]
"39" -> "40" [dir=forward tooltip="include"]
"62" -> "3" [dir=forward tooltip="include"]
"62" -> "4" [dir=forward tooltip="include"]
"62" -> "23" [dir=forward tooltip="include"]
"46" -> "18" [dir=forward tooltip="include"]
"73" -> "13" [dir=forward tooltip="include"]
"73" -> "16" [dir=forward tooltip="include"]
"73" -> "15" [dir=forward tooltip="include"]
"73" -> "10" [dir=forward tooltip="include"]
"73" -> "3" [dir=forward tooltip="include"]
"73" -> "2" [dir=forward tooltip="include"]
"52" -> "13" [dir=forward tooltip="include"]
"52" -> "16" [dir=forward tooltip="include"]
"52" -> "15" [dir=forward tooltip="include"]
"52" -> "33" [dir=forward tooltip="include"]
"52" -> "41" [dir=forward tooltip="include"]
"66" -> "18" [dir=forward tooltip="include"]
"66" -> "2" [dir=forward tooltip="include"]
"66" -> "44" [dir=forward tooltip="include"]
"66" -> "67" [dir=forward tooltip="include"]
"30" -> "31" [dir=forward tooltip="include"]
"30" -> "7" [dir=forward tooltip="include"]
"41" -> "7" [dir=forward tooltip="include"]
"41" -> "13" [dir=forward tooltip="include"]
"41" -> "14" [dir=forward tooltip="include"]
"41" -> "16" [dir=forward tooltip="include"]
"41" -> "3" [dir=forward tooltip="include"]
"70" -> "2" [dir=forward tooltip="include"]
"70" -> "33" [dir=forward tooltip="include"]
"70" -> "31" [dir=forward tooltip="include"]
"70" -> "51" [dir=forward tooltip="include"]
"70" -> "18" [dir=forward tooltip="include"]
"70" -> "66" [dir=forward tooltip="include"]
"70" -> "71" [dir=forward tooltip="include"]
"70" -> "74" [dir=forward tooltip="include"]
"71" -> "72" [dir=forward tooltip="include"]
"71" -> "33" [dir=forward tooltip="include"]
"71" -> "18" [dir=forward tooltip="include"]
"71" -> "73" [dir=forward tooltip="include"]
"68" -> "69" [dir=forward tooltip="include"]
"68" -> "18" [dir=forward tooltip="include"]
"69" -> "61" [dir=forward tooltip="include"]
"69" -> "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" -> "25" [dir=forward tooltip="include"]
"21" -> "26" [dir=forward tooltip="include"]
"21" -> "27" [dir=forward tooltip="include"]
"21" -> "28" [dir=forward tooltip="include"]
"21" -> "29" [dir=forward tooltip="include"]
"21" -> "32" [dir=forward tooltip="include"]
"21" -> "43" [dir=forward tooltip="include"]
"21" -> "52" [dir=forward tooltip="include"]
"21" -> "41" [dir=forward tooltip="include"]
"21" -> "53" [dir=forward tooltip="include"]
"21" -> "59" [dir=forward tooltip="include"]
"21" -> "60" [dir=forward tooltip="include"]
"21" -> "61" [dir=forward tooltip="include"]
"21" -> "63" [dir=forward tooltip="include"]
"21" -> "39" [dir=forward tooltip="include"]
"21" -> "6" [dir=forward tooltip="include"]
"19" -> "20" [dir=forward tooltip="include"]
"19" -> "21" [dir=forward tooltip="include"]
"19" -> "39" [dir=forward tooltip="include"]
"64" -> "61" [dir=forward tooltip="include"]
"64" -> "21" [dir=forward tooltip="include"]
"43" -> "2" [dir=forward tooltip="include"]
"43" -> "4" [dir=forward tooltip="include"]
"43" -> "44" [dir=forward tooltip="include"]
"43" -> "45" [dir=forward tooltip="include"]
"43" -> "46" [dir=forward tooltip="include"]
"43" -> "47" [dir=forward tooltip="include"]
"43" -> "48" [dir=forward tooltip="include"]
"43" -> "6" [dir=forward tooltip="include"]
"65" -> "3" [dir=forward tooltip="include"]
"65" -> "2" [dir=forward tooltip="include"]
"65" -> "22" [dir=forward tooltip="include"]
"65" -> "4" [dir=forward tooltip="include"]
"65" -> "55" [dir=forward tooltip="include"]
"65" -> "39" [dir=forward tooltip="include"]
"59" -> "2" [dir=forward tooltip="include"]
"59" -> "33" [dir=forward tooltip="include"]
"59" -> "41" [dir=forward tooltip="include"]
"59" -> "47" [dir=forward tooltip="include"]
"61" -> "10" [dir=forward tooltip="include"]
"61" -> "3" [dir=forward tooltip="include"]
"61" -> "40" [dir=forward tooltip="include"]
"61" -> "20" [dir=forward tooltip="include"]
"61" -> "38" [dir=forward tooltip="include"]
"61" -> "33" [dir=forward tooltip="include"]
"61" -> "23" [dir=forward tooltip="include"]
"61" -> "47" [dir=forward tooltip="include"]
"61" -> "55" [dir=forward tooltip="include"]
"61" -> "62" [dir=forward tooltip="include"]
"61" -> "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" -> "66" [dir=forward tooltip="include"]
"1" -> "68" [dir=forward tooltip="include"]
"1" -> "70" [dir=forward tooltip="include"]
"35" -> "36" [dir=forward tooltip="include"]
"35" -> "11" [dir=forward tooltip="include"]
"35" -> "13" [dir=forward tooltip="include"]
"35" -> "14" [dir=forward tooltip="include"]
"35" -> "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" -> "64" [dir=forward tooltip="include"]
"5" -> "65" [dir=forward tooltip="include"]
"5" -> "23" [dir=forward tooltip="include"]
"5" -> "32" [dir=forward tooltip="include"]
"5" -> "29" [dir=forward tooltip="include"]
"32" -> "8" [dir=forward tooltip="include"]
"32" -> "7" [dir=forward tooltip="include"]
"32" -> "2" [dir=forward tooltip="include"]
"32" -> "3" [dir=forward tooltip="include"]
"32" -> "33" [dir=forward tooltip="include"]
"32" -> "31" [dir=forward tooltip="include"]
"32" -> "20" [dir=forward tooltip="include"]
"32" -> "34" [dir=forward tooltip="include"]
"32" -> "35" [dir=forward tooltip="include"]
"32" -> "37" [dir=forward tooltip="include"]
"32" -> "23" [dir=forward tooltip="include"]
"32" -> "41" [dir=forward tooltip="include"]
"32" -> "30" [dir=forward tooltip="include"]
"32" -> "42" [dir=forward tooltip="include"]
}](_images/graphviz-d37371ccbfce2aa21047fbdddaf5ff4e359250ac.png)
- 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"]
"10" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"5" [label="Coefficients.H" tooltip="Coefficients.H"]
"34" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
"26" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
"33" [label="QPDistF.H" tooltip="QPDistF.H"]
"12" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
"44" [label="StringTok.H" tooltip="StringTok.H"]
"45" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"39" [label="biorth.H" tooltip="biorth.H"]
"37" [label="biorth1d.H" tooltip="biorth1d.H"]
"30" [label="gaussQ.H" tooltip="gaussQ.H"]
"24" [label="interp.H" tooltip="interp.H"]
"36" [label="libvars.H" tooltip="libvars.H"]
"18" [label="localmpi.H" tooltip="localmpi.H"]
"21" [label="massmodel.H" tooltip="massmodel.H"]
"28" [label="orbit.H" tooltip="orbit.H"]
"35" [label="sltableMP2.H" tooltip="sltableMP2.H"]
"40" [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"]
"3" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"43" [label="Particle.H" tooltip="Particle.H"]
"41" [label="chrono" tooltip="chrono"]
"38" [label="cmath" tooltip="cmath"]
"2" [label="complex" tooltip="complex"]
"20" [label="config_exp.h" tooltip="config_exp.h"]
"32" [label="cstdlib" tooltip="cstdlib"]
"25" [label="deque" tooltip="deque"]
"15" [label="fstream" tooltip="fstream"]
"29" [label="functional" tooltip="functional"]
"8" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"19" [label="iomanip" tooltip="iomanip"]
"14" [label="iostream" tooltip="iostream"]
"42" [label="list" tooltip="list"]
"27" [label="map" tooltip="map"]
"13" [label="math.h" tooltip="math.h"]
"11" [label="memory" tooltip="memory"]
"17" [label="mpi.h" tooltip="mpi.h"]
"23" [label="random" tooltip="random"]
"46" [label="set" tooltip="set"]
"31" [label="sstream" tooltip="sstream"]
"7" [label="stdexcept" tooltip="stdexcept"]
"16" [label="string" tooltip="string"]
"6" [label="tuple" tooltip="tuple"]
"4" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"22" [label="vector" tooltip="vector"]
"9" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"10" -> "11" [dir=forward tooltip="include"]
"10" -> "3" [dir=forward tooltip="include"]
"10" -> "4" [dir=forward tooltip="include"]
"5" -> "6" [dir=forward tooltip="include"]
"5" -> "7" [dir=forward tooltip="include"]
"5" -> "8" [dir=forward tooltip="include"]
"5" -> "3" [dir=forward tooltip="include"]
"5" -> "4" [dir=forward tooltip="include"]
"5" -> "9" [dir=forward tooltip="include"]
"5" -> "10" [dir=forward tooltip="include"]
"34" -> "21" [dir=forward tooltip="include"]
"26" -> "22" [dir=forward tooltip="include"]
"26" -> "27" [dir=forward tooltip="include"]
"26" -> "16" [dir=forward tooltip="include"]
"33" -> "19" [dir=forward tooltip="include"]
"33" -> "16" [dir=forward tooltip="include"]
"33" -> "27" [dir=forward tooltip="include"]
"33" -> "21" [dir=forward tooltip="include"]
"33" -> "34" [dir=forward tooltip="include"]
"33" -> "28" [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" -> "20" [dir=forward tooltip="include"]
"12" -> "21" [dir=forward tooltip="include"]
"12" -> "35" [dir=forward tooltip="include"]
"12" -> "9" [dir=forward tooltip="include"]
"12" -> "36" [dir=forward tooltip="include"]
"45" -> "16" [dir=forward tooltip="include"]
"45" -> "46" [dir=forward tooltip="include"]
"45" -> "9" [dir=forward tooltip="include"]
"39" -> "14" [dir=forward tooltip="include"]
"39" -> "19" [dir=forward tooltip="include"]
"39" -> "32" [dir=forward tooltip="include"]
"39" -> "16" [dir=forward tooltip="include"]
"39" -> "11" [dir=forward tooltip="include"]
"39" -> "3" [dir=forward tooltip="include"]
"37" -> "38" [dir=forward tooltip="include"]
"37" -> "39" [dir=forward tooltip="include"]
"30" -> "14" [dir=forward tooltip="include"]
"30" -> "19" [dir=forward tooltip="include"]
"30" -> "31" [dir=forward tooltip="include"]
"30" -> "32" [dir=forward tooltip="include"]
"30" -> "16" [dir=forward tooltip="include"]
"30" -> "22" [dir=forward tooltip="include"]
"24" -> "3" [dir=forward tooltip="include"]
"24" -> "22" [dir=forward tooltip="include"]
"24" -> "25" [dir=forward tooltip="include"]
"24" -> "26" [dir=forward tooltip="include"]
"36" -> "23" [dir=forward tooltip="include"]
"36" -> "17" [dir=forward tooltip="include"]
"18" -> "17" [dir=forward tooltip="include"]
"18" -> "14" [dir=forward tooltip="include"]
"18" -> "15" [dir=forward tooltip="include"]
"18" -> "19" [dir=forward tooltip="include"]
"18" -> "16" [dir=forward tooltip="include"]
"21" -> "22" [dir=forward tooltip="include"]
"21" -> "11" [dir=forward tooltip="include"]
"21" -> "23" [dir=forward tooltip="include"]
"21" -> "6" [dir=forward tooltip="include"]
"21" -> "3" [dir=forward tooltip="include"]
"21" -> "24" [dir=forward tooltip="include"]
"21" -> "28" [dir=forward tooltip="include"]
"21" -> "33" [dir=forward tooltip="include"]
"28" -> "29" [dir=forward tooltip="include"]
"28" -> "11" [dir=forward tooltip="include"]
"28" -> "3" [dir=forward tooltip="include"]
"28" -> "30" [dir=forward tooltip="include"]
"35" -> "3" [dir=forward tooltip="include"]
"40" -> "32" [dir=forward tooltip="include"]
"40" -> "16" [dir=forward tooltip="include"]
"40" -> "41" [dir=forward tooltip="include"]
"40" -> "42" [dir=forward tooltip="include"]
"40" -> "27" [dir=forward tooltip="include"]
"40" -> "11" [dir=forward tooltip="include"]
"40" -> "9" [dir=forward tooltip="include"]
"40" -> "43" [dir=forward tooltip="include"]
"40" -> "44" [dir=forward tooltip="include"]
"40" -> "45" [dir=forward tooltip="include"]
"40" -> "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" -> "12" [dir=forward tooltip="include"]
"1" -> "37" [dir=forward tooltip="include"]
"1" -> "40" [dir=forward tooltip="include"]
}](_images/graphviz-46cef40826a24793b9dd9ffb4381442884020dc2.png)
- 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"]
"47" [label="CoefContainer.H" tooltip="CoefContainer.H"]
"45" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"41" [label="Coefficients.H" tooltip="Coefficients.H"]
"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"]
"46" [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"]
"48" [label="Eigen/Dense" tooltip="Eigen/Dense"]
"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"]
"43" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"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"]
"42" [label="stdexcept" tooltip="stdexcept"]
"8" [label="string" tooltip="string"]
"16" [label="tuple" tooltip="tuple"]
"44" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"14" [label="vector" tooltip="vector"]
"29" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"47" -> "2" [dir=forward tooltip="include"]
"47" -> "16" [dir=forward tooltip="include"]
"47" -> "3" [dir=forward tooltip="include"]
"47" -> "32" [dir=forward tooltip="include"]
"47" -> "48" [dir=forward tooltip="include"]
"47" -> "41" [dir=forward tooltip="include"]
"45" -> "2" [dir=forward tooltip="include"]
"45" -> "17" [dir=forward tooltip="include"]
"45" -> "44" [dir=forward tooltip="include"]
"41" -> "16" [dir=forward tooltip="include"]
"41" -> "42" [dir=forward tooltip="include"]
"41" -> "43" [dir=forward tooltip="include"]
"41" -> "17" [dir=forward tooltip="include"]
"41" -> "44" [dir=forward tooltip="include"]
"41" -> "29" [dir=forward tooltip="include"]
"41" -> "45" [dir=forward tooltip="include"]
"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"]
"46" -> "2" [dir=forward tooltip="include"]
"46" -> "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" -> "46" [dir=forward tooltip="include"]
"31" -> "47" [dir=forward tooltip="include"]
}](_images/graphviz-1c299df7e0a299d949974195e24280411ca24aea.png)
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"]
}](_images/graphviz-66e8beb530b859575d6612c27773355878c6a03b.png)
- file SphericalBasis.H
- #include <memory>#include <random>#include <vector>#include <string>#include <set>#include <AxisymmetricBasis.H>#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"]
"27" [label="CoefContainer.H" tooltip="CoefContainer.H"]
"25" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"20" [label="Coefficients.H" tooltip="Coefficients.H"]
"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"]
"26" [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"]
"28" [label="Eigen/Dense" tooltip="Eigen/Dense"]
"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"]
"23" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"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"]
"22" [label="stdexcept" tooltip="stdexcept"]
"5" [label="string" tooltip="string"]
"21" [label="tuple" tooltip="tuple"]
"24" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"4" [label="vector" tooltip="vector"]
"14" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"27" -> "2" [dir=forward tooltip="include"]
"27" -> "21" [dir=forward tooltip="include"]
"27" -> "13" [dir=forward tooltip="include"]
"27" -> "6" [dir=forward tooltip="include"]
"27" -> "28" [dir=forward tooltip="include"]
"27" -> "20" [dir=forward tooltip="include"]
"25" -> "2" [dir=forward tooltip="include"]
"25" -> "19" [dir=forward tooltip="include"]
"25" -> "24" [dir=forward tooltip="include"]
"20" -> "21" [dir=forward tooltip="include"]
"20" -> "22" [dir=forward tooltip="include"]
"20" -> "23" [dir=forward tooltip="include"]
"20" -> "19" [dir=forward tooltip="include"]
"20" -> "24" [dir=forward tooltip="include"]
"20" -> "14" [dir=forward tooltip="include"]
"20" -> "25" [dir=forward tooltip="include"]
"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"]
"26" -> "2" [dir=forward tooltip="include"]
"26" -> "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" -> "26" [dir=forward tooltip="include"]
"1" -> "27" [dir=forward tooltip="include"]
}](_images/graphviz-e91996a5d97f4a631663fd29493d9f0052a1b518.png)
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"]
}](_images/graphviz-45a1286dcfffa519c748085d0b801130171ad78e.png)
- 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"]
}](_images/graphviz-fbe650c05a52918adf1d6517e584355c30a14427.png)
- 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"]
}](_images/graphviz-ccf286f4a75cd9109e0e72b3ff3bd26104e0ecd7.png)
- file tipsydefs.h
-
Typedefs
-
typedef float Real
Variables
-
struct dark_particle *dark_particles
-
struct gas_particle *gas_particles
-
struct star_particle *star_particles
-
typedef float Real
- file tipsydefs.h
Defines
-
MAXDIM
Typedefs
-
typedef float Real
Variables
-
struct dark_particle *dark_particles
-
struct gas_particle *gas_particles
-
struct dump header
-
struct star_particle *star_particles
-
MAXDIM
- 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"]
"48" [label="CoefContainer.H" tooltip="CoefContainer.H"]
"46" [label="CoefStruct.H" tooltip="CoefStruct.H"]
"42" [label="Coefficients.H" tooltip="Coefficients.H"]
"66" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"87" [label="CenterFile.H" tooltip="CenterFile.H"]
"88" [label="Circular.H" tooltip="Circular.H"]
"27" [label="DiskWithHalo.H" tooltip="DiskWithHalo.H"]
"79" [label="EXPException.H" tooltip="EXPException.H"]
"91" [label="EmpCylSL.H" tooltip="EmpCylSL.H"]
"19" [label="MonotCubicInterpolator.H" tooltip="MonotCubicInterpolator.H"]
"83" [label="Particle.H" tooltip="Particle.H"]
"81" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"56" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"26" [label="QPDistF.H" tooltip="QPDistF.H"]
"58" [label="QuadLS.H" tooltip="QuadLS.H"]
"2" [label="SLGridMP2.H" tooltip="SLGridMP2.H"]
"68" [label="Species.H" tooltip="Species.H"]
"40" [label="StringTok.H" tooltip="StringTok.H"]
"67" [label="Timer.H" tooltip="Timer.H"]
"41" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"92" [label="coef.H" tooltip="coef.H"]
"55" [label="euler.H" tooltip="euler.H"]
"84" [label="gadget.H" tooltip="gadget.H"]
"23" [label="gaussQ.H" tooltip="gaussQ.H"]
"80" [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"]
"85" [label="tipsy.H" tooltip="tipsy.H"]
"34" [label="AxisymmetricBasis.H" tooltip="AxisymmetricBasis.H"]
"35" [label="Basis.H" tooltip="Basis.H"]
"50" [label="Bessel.H" tooltip="Bessel.H"]
"73" [label="Component.H" tooltip="Component.H"]
"72" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
"59" [label="CylEXP.H" tooltip="CylEXP.H"]
"52" [label="Cylinder.H" tooltip="Cylinder.H"]
"89" [label="ExternalForce.H" tooltip="ExternalForce.H"]
"47" [label="NVTX.H" tooltip="NVTX.H"]
"53" [label="Orient.H" tooltip="Orient.H"]
"90" [label="Output.H" tooltip="Output.H"]
"86" [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"]
"63" [label="chkTimer.H" tooltip="chkTimer.H"]
"62" [label="coef.H" tooltip="coef.H"]
"69" [label="expand.H" tooltip="expand.H"]
"60" [label="global.H" tooltip="global.H"]
"49" [label="Eigen/Dense" tooltip="Eigen/Dense"]
"16" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"75" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"39" [label="Particle.H" tooltip="Particle.H"]
"54" [label="algorithm" tooltip="algorithm"]
"57" [label="array" tooltip="array"]
"51" [label="assert.h" tooltip="assert.h"]
"37" [label="chrono" tooltip="chrono"]
"65" [label="cmath" tooltip="cmath"]
"10" [label="config_exp.h" tooltip="config_exp.h"]
"25" [label="cstdlib" tooltip="cstdlib"]
"70" [label="cstring" tooltip="cstring"]
"18" [label="deque" tooltip="deque"]
"5" [label="fstream" tooltip="fstream"]
"22" [label="functional" tooltip="functional"]
"78" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"76" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"77" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"44" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"9" [label="iomanip" tooltip="iomanip"]
"4" [label="iostream" tooltip="iostream"]
"71" [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"]
"61" [label="pthread.h" tooltip="pthread.h"]
"14" [label="random" tooltip="random"]
"33" [label="set" tooltip="set"]
"24" [label="sstream" tooltip="sstream"]
"43" [label="stdexcept" tooltip="stdexcept"]
"6" [label="string" tooltip="string"]
"64" [label="time.h" tooltip="time.h"]
"15" [label="tuple" tooltip="tuple"]
"82" [label="unordered_map" tooltip="unordered_map"]
"45" [label="unsupported/Eigen/CXX11/Tensor" tooltip="unsupported/Eigen/CXX11/Tensor"]
"74" [label="utility" tooltip="utility"]
"12" [label="vector" tooltip="vector"]
"29" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"48" -> "13" [dir=forward tooltip="include"]
"48" -> "15" [dir=forward tooltip="include"]
"48" -> "20" [dir=forward tooltip="include"]
"48" -> "33" [dir=forward tooltip="include"]
"48" -> "49" [dir=forward tooltip="include"]
"48" -> "42" [dir=forward tooltip="include"]
"46" -> "13" [dir=forward tooltip="include"]
"46" -> "16" [dir=forward tooltip="include"]
"46" -> "45" [dir=forward tooltip="include"]
"42" -> "15" [dir=forward tooltip="include"]
"42" -> "43" [dir=forward tooltip="include"]
"42" -> "44" [dir=forward tooltip="include"]
"42" -> "16" [dir=forward tooltip="include"]
"42" -> "45" [dir=forward tooltip="include"]
"42" -> "29" [dir=forward tooltip="include"]
"42" -> "46" [dir=forward tooltip="include"]
"66" -> "4" [dir=forward tooltip="include"]
"66" -> "9" [dir=forward tooltip="include"]
"66" -> "12" [dir=forward tooltip="include"]
"66" -> "6" [dir=forward tooltip="include"]
"66" -> "38" [dir=forward tooltip="include"]
"66" -> "20" [dir=forward tooltip="include"]
"66" -> "33" [dir=forward tooltip="include"]
"66" -> "13" [dir=forward tooltip="include"]
"66" -> "67" [dir=forward tooltip="include"]
"66" -> "7" [dir=forward tooltip="include"]
"87" -> "5" [dir=forward tooltip="include"]
"87" -> "12" [dir=forward tooltip="include"]
"87" -> "57" [dir=forward tooltip="include"]
"87" -> "29" [dir=forward tooltip="include"]
"88" -> "12" [dir=forward tooltip="include"]
"27" -> "11" [dir=forward tooltip="include"]
"79" -> "33" [dir=forward tooltip="include"]
"79" -> "12" [dir=forward tooltip="include"]
"79" -> "6" [dir=forward tooltip="include"]
"79" -> "24" [dir=forward tooltip="include"]
"79" -> "30" [dir=forward tooltip="include"]
"91" -> "22" [dir=forward tooltip="include"]
"91" -> "12" [dir=forward tooltip="include"]
"91" -> "13" [dir=forward tooltip="include"]
"91" -> "71" [dir=forward tooltip="include"]
"91" -> "65" [dir=forward tooltip="include"]
"91" -> "16" [dir=forward tooltip="include"]
"91" -> "23" [dir=forward tooltip="include"]
"91" -> "17" [dir=forward tooltip="include"]
"91" -> "67" [dir=forward tooltip="include"]
"91" -> "83" [dir=forward tooltip="include"]
"91" -> "2" [dir=forward tooltip="include"]
"91" -> "92" [dir=forward tooltip="include"]
"91" -> "30" [dir=forward tooltip="include"]
"19" -> "12" [dir=forward tooltip="include"]
"19" -> "20" [dir=forward tooltip="include"]
"19" -> "6" [dir=forward tooltip="include"]
"83" -> "82" [dir=forward tooltip="include"]
"83" -> "12" [dir=forward tooltip="include"]
"83" -> "13" [dir=forward tooltip="include"]
"81" -> "82" [dir=forward tooltip="include"]
"81" -> "43" [dir=forward tooltip="include"]
"81" -> "54" [dir=forward tooltip="include"]
"81" -> "4" [dir=forward tooltip="include"]
"81" -> "5" [dir=forward tooltip="include"]
"81" -> "9" [dir=forward tooltip="include"]
"81" -> "12" [dir=forward tooltip="include"]
"81" -> "13" [dir=forward tooltip="include"]
"81" -> "6" [dir=forward tooltip="include"]
"81" -> "65" [dir=forward tooltip="include"]
"81" -> "38" [dir=forward tooltip="include"]
"81" -> "7" [dir=forward tooltip="include"]
"81" -> "10" [dir=forward tooltip="include"]
"81" -> "40" [dir=forward tooltip="include"]
"81" -> "80" [dir=forward tooltip="include"]
"81" -> "83" [dir=forward tooltip="include"]
"81" -> "84" [dir=forward tooltip="include"]
"81" -> "85" [dir=forward tooltip="include"]
"56" -> "18" [dir=forward tooltip="include"]
"56" -> "57" [dir=forward tooltip="include"]
"56" -> "16" [dir=forward tooltip="include"]
"56" -> "58" [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"]
"58" -> "4" [dir=forward tooltip="include"]
"58" -> "9" [dir=forward tooltip="include"]
"58" -> "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"]
"68" -> "20" [dir=forward tooltip="include"]
"68" -> "33" [dir=forward tooltip="include"]
"68" -> "12" [dir=forward tooltip="include"]
"67" -> "4" [dir=forward tooltip="include"]
"67" -> "25" [dir=forward tooltip="include"]
"67" -> "37" [dir=forward tooltip="include"]
"41" -> "6" [dir=forward tooltip="include"]
"41" -> "33" [dir=forward tooltip="include"]
"41" -> "29" [dir=forward tooltip="include"]
"55" -> "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"]
"80" -> "4" [dir=forward tooltip="include"]
"80" -> "9" [dir=forward tooltip="include"]
"80" -> "24" [dir=forward tooltip="include"]
"80" -> "13" [dir=forward tooltip="include"]
"80" -> "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"]
"50" -> "51" [dir=forward tooltip="include"]
"50" -> "32" [dir=forward tooltip="include"]
"73" -> "7" [dir=forward tooltip="include"]
"73" -> "74" [dir=forward tooltip="include"]
"73" -> "29" [dir=forward tooltip="include"]
"73" -> "75" [dir=forward tooltip="include"]
"73" -> "44" [dir=forward tooltip="include"]
"73" -> "76" [dir=forward tooltip="include"]
"73" -> "77" [dir=forward tooltip="include"]
"73" -> "78" [dir=forward tooltip="include"]
"73" -> "79" [dir=forward tooltip="include"]
"73" -> "60" [dir=forward tooltip="include"]
"73" -> "53" [dir=forward tooltip="include"]
"73" -> "80" [dir=forward tooltip="include"]
"73" -> "8" [dir=forward tooltip="include"]
"73" -> "81" [dir=forward tooltip="include"]
"73" -> "86" [dir=forward tooltip="include"]
"73" -> "87" [dir=forward tooltip="include"]
"73" -> "36" [dir=forward tooltip="include"]
"73" -> "88" [dir=forward tooltip="include"]
"73" -> "67" [dir=forward tooltip="include"]
"73" -> "10" [dir=forward tooltip="include"]
"72" -> "38" [dir=forward tooltip="include"]
"72" -> "73" [dir=forward tooltip="include"]
"72" -> "67" [dir=forward tooltip="include"]
"59" -> "60" [dir=forward tooltip="include"]
"59" -> "69" [dir=forward tooltip="include"]
"59" -> "91" [dir=forward tooltip="include"]
"52" -> "13" [dir=forward tooltip="include"]
"52" -> "53" [dir=forward tooltip="include"]
"52" -> "35" [dir=forward tooltip="include"]
"52" -> "59" [dir=forward tooltip="include"]
"52" -> "42" [dir=forward tooltip="include"]
"52" -> "10" [dir=forward tooltip="include"]
"52" -> "48" [dir=forward tooltip="include"]
"89" -> "36" [dir=forward tooltip="include"]
"89" -> "73" [dir=forward tooltip="include"]
"47" -> "13" [dir=forward tooltip="include"]
"47" -> "10" [dir=forward tooltip="include"]
"53" -> "12" [dir=forward tooltip="include"]
"53" -> "33" [dir=forward tooltip="include"]
"53" -> "18" [dir=forward tooltip="include"]
"53" -> "54" [dir=forward tooltip="include"]
"53" -> "55" [dir=forward tooltip="include"]
"53" -> "39" [dir=forward tooltip="include"]
"53" -> "56" [dir=forward tooltip="include"]
"53" -> "10" [dir=forward tooltip="include"]
"90" -> "6" [dir=forward tooltip="include"]
"90" -> "12" [dir=forward tooltip="include"]
"90" -> "74" [dir=forward tooltip="include"]
"90" -> "33" [dir=forward tooltip="include"]
"90" -> "40" [dir=forward tooltip="include"]
"90" -> "67" [dir=forward tooltip="include"]
"86" -> "12" [dir=forward tooltip="include"]
"86" -> "13" [dir=forward tooltip="include"]
"86" -> "8" [dir=forward tooltip="include"]
"86" -> "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" -> "47" [dir=forward tooltip="include"]
"32" -> "48" [dir=forward tooltip="include"]
"1" -> "2" [dir=forward tooltip="include"]
"1" -> "31" [dir=forward tooltip="include"]
"1" -> "50" [dir=forward tooltip="include"]
"1" -> "52" [dir=forward tooltip="include"]
"63" -> "64" [dir=forward tooltip="include"]
"63" -> "65" [dir=forward tooltip="include"]
"63" -> "4" [dir=forward tooltip="include"]
"63" -> "5" [dir=forward tooltip="include"]
"63" -> "9" [dir=forward tooltip="include"]
"69" -> "10" [dir=forward tooltip="include"]
"69" -> "7" [dir=forward tooltip="include"]
"69" -> "61" [dir=forward tooltip="include"]
"69" -> "43" [dir=forward tooltip="include"]
"69" -> "25" [dir=forward tooltip="include"]
"69" -> "65" [dir=forward tooltip="include"]
"69" -> "70" [dir=forward tooltip="include"]
"69" -> "4" [dir=forward tooltip="include"]
"69" -> "5" [dir=forward tooltip="include"]
"69" -> "24" [dir=forward tooltip="include"]
"69" -> "9" [dir=forward tooltip="include"]
"69" -> "12" [dir=forward tooltip="include"]
"69" -> "6" [dir=forward tooltip="include"]
"69" -> "71" [dir=forward tooltip="include"]
"69" -> "16" [dir=forward tooltip="include"]
"69" -> "72" [dir=forward tooltip="include"]
"69" -> "89" [dir=forward tooltip="include"]
"69" -> "90" [dir=forward tooltip="include"]
"69" -> "29" [dir=forward tooltip="include"]
"69" -> "60" [dir=forward tooltip="include"]
"69" -> "79" [dir=forward tooltip="include"]
"60" -> "61" [dir=forward tooltip="include"]
"60" -> "7" [dir=forward tooltip="include"]
"60" -> "12" [dir=forward tooltip="include"]
"60" -> "6" [dir=forward tooltip="include"]
"60" -> "13" [dir=forward tooltip="include"]
"60" -> "14" [dir=forward tooltip="include"]
"60" -> "38" [dir=forward tooltip="include"]
"60" -> "62" [dir=forward tooltip="include"]
"60" -> "63" [dir=forward tooltip="include"]
"60" -> "66" [dir=forward tooltip="include"]
"60" -> "29" [dir=forward tooltip="include"]
"60" -> "8" [dir=forward tooltip="include"]
"60" -> "30" [dir=forward tooltip="include"]
"60" -> "68" [dir=forward tooltip="include"]
}](_images/graphviz-741947a1cb66ac13c1865f090ca3e31fa3d7b8b8.png)
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"]
}](_images/graphviz-b071b24b0dbe1fb6cb2e482ec4fd0272c2c3adff.png)
- 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"]
}](_images/graphviz-1392bb19ed426d8b88bc60c568397caf1c8af678.png)
- file UserBar.H
- #include <Particle.H>#include <AxisymmetricBasis.H>#include <ExternalCollection.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"]
"42" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"62" [label="CenterFile.H" tooltip="CenterFile.H"]
"63" [label="Circular.H" tooltip="Circular.H"]
"28" [label="EXPException.H" tooltip="EXPException.H"]
"58" [label="Particle.H" tooltip="Particle.H"]
"55" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"50" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"52" [label="QuadLS.H" tooltip="QuadLS.H"]
"45" [label="Species.H" tooltip="Species.H"]
"13" [label="StringTok.H" tooltip="StringTok.H"]
"43" [label="Timer.H" tooltip="Timer.H"]
"14" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"49" [label="euler.H" tooltip="euler.H"]
"59" [label="gadget.H" tooltip="gadget.H"]
"54" [label="header.H" tooltip="header.H"]
"31" [label="libvars.H" tooltip="libvars.H"]
"44" [label="localmpi.H" tooltip="localmpi.H"]
"60" [label="tipsy.H" tooltip="tipsy.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"]
"64" [label="ExternalForce.H" tooltip="ExternalForce.H"]
"46" [label="Orient.H" tooltip="Orient.H"]
"61" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"5" [label="PotAccel.H" tooltip="PotAccel.H"]
"36" [label="chkTimer.H" tooltip="chkTimer.H"]
"35" [label="coef.H" tooltip="coef.H"]
"33" [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"]
"23" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"2" [label="Particle.H" tooltip="Particle.H"]
"48" [label="algorithm" tooltip="algorithm"]
"51" [label="array" tooltip="array"]
"8" [label="chrono" tooltip="chrono"]
"38" [label="cmath" tooltip="cmath"]
"16" [label="config_exp.h" tooltip="config_exp.h"]
"6" [label="cstdlib" tooltip="cstdlib"]
"47" [label="deque" tooltip="deque"]
"40" [label="fstream" tooltip="fstream"]
"27" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"25" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"26" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"24" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"41" [label="iomanip" tooltip="iomanip"]
"39" [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"]
"34" [label="pthread.h" tooltip="pthread.h"]
"32" [label="random" tooltip="random"]
"15" [label="set" tooltip="set"]
"30" [label="sstream" tooltip="sstream"]
"57" [label="stdexcept" tooltip="stdexcept"]
"7" [label="string" tooltip="string"]
"37" [label="time.h" tooltip="time.h"]
"53" [label="tuple" tooltip="tuple"]
"56" [label="unordered_map" tooltip="unordered_map"]
"22" [label="utility" tooltip="utility"]
"29" [label="vector" tooltip="vector"]
"12" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"42" -> "39" [dir=forward tooltip="include"]
"42" -> "41" [dir=forward tooltip="include"]
"42" -> "29" [dir=forward tooltip="include"]
"42" -> "7" [dir=forward tooltip="include"]
"42" -> "9" [dir=forward tooltip="include"]
"42" -> "10" [dir=forward tooltip="include"]
"42" -> "15" [dir=forward tooltip="include"]
"42" -> "11" [dir=forward tooltip="include"]
"42" -> "43" [dir=forward tooltip="include"]
"42" -> "21" [dir=forward tooltip="include"]
"62" -> "40" [dir=forward tooltip="include"]
"62" -> "29" [dir=forward tooltip="include"]
"62" -> "51" [dir=forward tooltip="include"]
"62" -> "12" [dir=forward tooltip="include"]
"63" -> "29" [dir=forward tooltip="include"]
"28" -> "15" [dir=forward tooltip="include"]
"28" -> "29" [dir=forward tooltip="include"]
"28" -> "7" [dir=forward tooltip="include"]
"28" -> "30" [dir=forward tooltip="include"]
"28" -> "31" [dir=forward tooltip="include"]
"58" -> "56" [dir=forward tooltip="include"]
"58" -> "29" [dir=forward tooltip="include"]
"58" -> "11" [dir=forward tooltip="include"]
"55" -> "56" [dir=forward tooltip="include"]
"55" -> "57" [dir=forward tooltip="include"]
"55" -> "48" [dir=forward tooltip="include"]
"55" -> "39" [dir=forward tooltip="include"]
"55" -> "40" [dir=forward tooltip="include"]
"55" -> "41" [dir=forward tooltip="include"]
"55" -> "29" [dir=forward tooltip="include"]
"55" -> "11" [dir=forward tooltip="include"]
"55" -> "7" [dir=forward tooltip="include"]
"55" -> "38" [dir=forward tooltip="include"]
"55" -> "9" [dir=forward tooltip="include"]
"55" -> "21" [dir=forward tooltip="include"]
"55" -> "16" [dir=forward tooltip="include"]
"55" -> "13" [dir=forward tooltip="include"]
"55" -> "54" [dir=forward tooltip="include"]
"55" -> "58" [dir=forward tooltip="include"]
"55" -> "59" [dir=forward tooltip="include"]
"55" -> "60" [dir=forward tooltip="include"]
"50" -> "47" [dir=forward tooltip="include"]
"50" -> "51" [dir=forward tooltip="include"]
"50" -> "17" [dir=forward tooltip="include"]
"50" -> "52" [dir=forward tooltip="include"]
"52" -> "39" [dir=forward tooltip="include"]
"52" -> "41" [dir=forward tooltip="include"]
"52" -> "53" [dir=forward tooltip="include"]
"45" -> "10" [dir=forward tooltip="include"]
"45" -> "15" [dir=forward tooltip="include"]
"45" -> "29" [dir=forward tooltip="include"]
"43" -> "39" [dir=forward tooltip="include"]
"43" -> "6" [dir=forward tooltip="include"]
"43" -> "8" [dir=forward tooltip="include"]
"14" -> "7" [dir=forward tooltip="include"]
"14" -> "15" [dir=forward tooltip="include"]
"14" -> "12" [dir=forward tooltip="include"]
"49" -> "17" [dir=forward tooltip="include"]
"54" -> "39" [dir=forward tooltip="include"]
"54" -> "41" [dir=forward tooltip="include"]
"54" -> "30" [dir=forward tooltip="include"]
"54" -> "11" [dir=forward tooltip="include"]
"54" -> "44" [dir=forward tooltip="include"]
"31" -> "32" [dir=forward tooltip="include"]
"31" -> "21" [dir=forward tooltip="include"]
"44" -> "21" [dir=forward tooltip="include"]
"44" -> "39" [dir=forward tooltip="include"]
"44" -> "40" [dir=forward tooltip="include"]
"44" -> "41" [dir=forward tooltip="include"]
"44" -> "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" -> "24" [dir=forward tooltip="include"]
"20" -> "25" [dir=forward tooltip="include"]
"20" -> "26" [dir=forward tooltip="include"]
"20" -> "27" [dir=forward tooltip="include"]
"20" -> "28" [dir=forward tooltip="include"]
"20" -> "33" [dir=forward tooltip="include"]
"20" -> "46" [dir=forward tooltip="include"]
"20" -> "54" [dir=forward tooltip="include"]
"20" -> "44" [dir=forward tooltip="include"]
"20" -> "55" [dir=forward tooltip="include"]
"20" -> "61" [dir=forward tooltip="include"]
"20" -> "62" [dir=forward tooltip="include"]
"20" -> "5" [dir=forward tooltip="include"]
"20" -> "63" [dir=forward tooltip="include"]
"20" -> "43" [dir=forward tooltip="include"]
"20" -> "16" [dir=forward tooltip="include"]
"19" -> "9" [dir=forward tooltip="include"]
"19" -> "20" [dir=forward tooltip="include"]
"19" -> "43" [dir=forward tooltip="include"]
"18" -> "10" [dir=forward tooltip="include"]
"18" -> "19" [dir=forward tooltip="include"]
"18" -> "64" [dir=forward tooltip="include"]
"64" -> "5" [dir=forward tooltip="include"]
"64" -> "20" [dir=forward tooltip="include"]
"46" -> "29" [dir=forward tooltip="include"]
"46" -> "15" [dir=forward tooltip="include"]
"46" -> "47" [dir=forward tooltip="include"]
"46" -> "48" [dir=forward tooltip="include"]
"46" -> "49" [dir=forward tooltip="include"]
"46" -> "2" [dir=forward tooltip="include"]
"46" -> "50" [dir=forward tooltip="include"]
"46" -> "16" [dir=forward tooltip="include"]
"61" -> "29" [dir=forward tooltip="include"]
"61" -> "11" [dir=forward tooltip="include"]
"61" -> "44" [dir=forward tooltip="include"]
"61" -> "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"]
"36" -> "37" [dir=forward tooltip="include"]
"36" -> "38" [dir=forward tooltip="include"]
"36" -> "39" [dir=forward tooltip="include"]
"36" -> "40" [dir=forward tooltip="include"]
"36" -> "41" [dir=forward tooltip="include"]
"33" -> "34" [dir=forward tooltip="include"]
"33" -> "21" [dir=forward tooltip="include"]
"33" -> "29" [dir=forward tooltip="include"]
"33" -> "7" [dir=forward tooltip="include"]
"33" -> "11" [dir=forward tooltip="include"]
"33" -> "32" [dir=forward tooltip="include"]
"33" -> "9" [dir=forward tooltip="include"]
"33" -> "35" [dir=forward tooltip="include"]
"33" -> "36" [dir=forward tooltip="include"]
"33" -> "42" [dir=forward tooltip="include"]
"33" -> "12" [dir=forward tooltip="include"]
"33" -> "44" [dir=forward tooltip="include"]
"33" -> "31" [dir=forward tooltip="include"]
"33" -> "45" [dir=forward tooltip="include"]
"1" -> "2" [dir=forward tooltip="include"]
"1" -> "3" [dir=forward tooltip="include"]
"1" -> "18" [dir=forward tooltip="include"]
}](_images/graphviz-f81764841d4547ca6966ce06c728350f7b2db57d.png)
- file UserDisk.H
- #include <Particle.H>#include <AxisymmetricBasis.H>#include <ExternalCollection.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"]
"42" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"62" [label="CenterFile.H" tooltip="CenterFile.H"]
"63" [label="Circular.H" tooltip="Circular.H"]
"28" [label="EXPException.H" tooltip="EXPException.H"]
"58" [label="Particle.H" tooltip="Particle.H"]
"55" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"50" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"52" [label="QuadLS.H" tooltip="QuadLS.H"]
"45" [label="Species.H" tooltip="Species.H"]
"13" [label="StringTok.H" tooltip="StringTok.H"]
"43" [label="Timer.H" tooltip="Timer.H"]
"14" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"49" [label="euler.H" tooltip="euler.H"]
"59" [label="gadget.H" tooltip="gadget.H"]
"54" [label="header.H" tooltip="header.H"]
"31" [label="libvars.H" tooltip="libvars.H"]
"44" [label="localmpi.H" tooltip="localmpi.H"]
"60" [label="tipsy.H" tooltip="tipsy.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"]
"64" [label="ExternalForce.H" tooltip="ExternalForce.H"]
"46" [label="Orient.H" tooltip="Orient.H"]
"61" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"5" [label="PotAccel.H" tooltip="PotAccel.H"]
"36" [label="chkTimer.H" tooltip="chkTimer.H"]
"35" [label="coef.H" tooltip="coef.H"]
"33" [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"]
"23" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"2" [label="Particle.H" tooltip="Particle.H"]
"48" [label="algorithm" tooltip="algorithm"]
"51" [label="array" tooltip="array"]
"8" [label="chrono" tooltip="chrono"]
"38" [label="cmath" tooltip="cmath"]
"16" [label="config_exp.h" tooltip="config_exp.h"]
"6" [label="cstdlib" tooltip="cstdlib"]
"47" [label="deque" tooltip="deque"]
"40" [label="fstream" tooltip="fstream"]
"27" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"25" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"26" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"24" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"41" [label="iomanip" tooltip="iomanip"]
"39" [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"]
"34" [label="pthread.h" tooltip="pthread.h"]
"32" [label="random" tooltip="random"]
"15" [label="set" tooltip="set"]
"30" [label="sstream" tooltip="sstream"]
"57" [label="stdexcept" tooltip="stdexcept"]
"7" [label="string" tooltip="string"]
"37" [label="time.h" tooltip="time.h"]
"53" [label="tuple" tooltip="tuple"]
"56" [label="unordered_map" tooltip="unordered_map"]
"22" [label="utility" tooltip="utility"]
"29" [label="vector" tooltip="vector"]
"12" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"42" -> "39" [dir=forward tooltip="include"]
"42" -> "41" [dir=forward tooltip="include"]
"42" -> "29" [dir=forward tooltip="include"]
"42" -> "7" [dir=forward tooltip="include"]
"42" -> "9" [dir=forward tooltip="include"]
"42" -> "10" [dir=forward tooltip="include"]
"42" -> "15" [dir=forward tooltip="include"]
"42" -> "11" [dir=forward tooltip="include"]
"42" -> "43" [dir=forward tooltip="include"]
"42" -> "21" [dir=forward tooltip="include"]
"62" -> "40" [dir=forward tooltip="include"]
"62" -> "29" [dir=forward tooltip="include"]
"62" -> "51" [dir=forward tooltip="include"]
"62" -> "12" [dir=forward tooltip="include"]
"63" -> "29" [dir=forward tooltip="include"]
"28" -> "15" [dir=forward tooltip="include"]
"28" -> "29" [dir=forward tooltip="include"]
"28" -> "7" [dir=forward tooltip="include"]
"28" -> "30" [dir=forward tooltip="include"]
"28" -> "31" [dir=forward tooltip="include"]
"58" -> "56" [dir=forward tooltip="include"]
"58" -> "29" [dir=forward tooltip="include"]
"58" -> "11" [dir=forward tooltip="include"]
"55" -> "56" [dir=forward tooltip="include"]
"55" -> "57" [dir=forward tooltip="include"]
"55" -> "48" [dir=forward tooltip="include"]
"55" -> "39" [dir=forward tooltip="include"]
"55" -> "40" [dir=forward tooltip="include"]
"55" -> "41" [dir=forward tooltip="include"]
"55" -> "29" [dir=forward tooltip="include"]
"55" -> "11" [dir=forward tooltip="include"]
"55" -> "7" [dir=forward tooltip="include"]
"55" -> "38" [dir=forward tooltip="include"]
"55" -> "9" [dir=forward tooltip="include"]
"55" -> "21" [dir=forward tooltip="include"]
"55" -> "16" [dir=forward tooltip="include"]
"55" -> "13" [dir=forward tooltip="include"]
"55" -> "54" [dir=forward tooltip="include"]
"55" -> "58" [dir=forward tooltip="include"]
"55" -> "59" [dir=forward tooltip="include"]
"55" -> "60" [dir=forward tooltip="include"]
"50" -> "47" [dir=forward tooltip="include"]
"50" -> "51" [dir=forward tooltip="include"]
"50" -> "17" [dir=forward tooltip="include"]
"50" -> "52" [dir=forward tooltip="include"]
"52" -> "39" [dir=forward tooltip="include"]
"52" -> "41" [dir=forward tooltip="include"]
"52" -> "53" [dir=forward tooltip="include"]
"45" -> "10" [dir=forward tooltip="include"]
"45" -> "15" [dir=forward tooltip="include"]
"45" -> "29" [dir=forward tooltip="include"]
"43" -> "39" [dir=forward tooltip="include"]
"43" -> "6" [dir=forward tooltip="include"]
"43" -> "8" [dir=forward tooltip="include"]
"14" -> "7" [dir=forward tooltip="include"]
"14" -> "15" [dir=forward tooltip="include"]
"14" -> "12" [dir=forward tooltip="include"]
"49" -> "17" [dir=forward tooltip="include"]
"54" -> "39" [dir=forward tooltip="include"]
"54" -> "41" [dir=forward tooltip="include"]
"54" -> "30" [dir=forward tooltip="include"]
"54" -> "11" [dir=forward tooltip="include"]
"54" -> "44" [dir=forward tooltip="include"]
"31" -> "32" [dir=forward tooltip="include"]
"31" -> "21" [dir=forward tooltip="include"]
"44" -> "21" [dir=forward tooltip="include"]
"44" -> "39" [dir=forward tooltip="include"]
"44" -> "40" [dir=forward tooltip="include"]
"44" -> "41" [dir=forward tooltip="include"]
"44" -> "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" -> "24" [dir=forward tooltip="include"]
"20" -> "25" [dir=forward tooltip="include"]
"20" -> "26" [dir=forward tooltip="include"]
"20" -> "27" [dir=forward tooltip="include"]
"20" -> "28" [dir=forward tooltip="include"]
"20" -> "33" [dir=forward tooltip="include"]
"20" -> "46" [dir=forward tooltip="include"]
"20" -> "54" [dir=forward tooltip="include"]
"20" -> "44" [dir=forward tooltip="include"]
"20" -> "55" [dir=forward tooltip="include"]
"20" -> "61" [dir=forward tooltip="include"]
"20" -> "62" [dir=forward tooltip="include"]
"20" -> "5" [dir=forward tooltip="include"]
"20" -> "63" [dir=forward tooltip="include"]
"20" -> "43" [dir=forward tooltip="include"]
"20" -> "16" [dir=forward tooltip="include"]
"19" -> "9" [dir=forward tooltip="include"]
"19" -> "20" [dir=forward tooltip="include"]
"19" -> "43" [dir=forward tooltip="include"]
"18" -> "10" [dir=forward tooltip="include"]
"18" -> "19" [dir=forward tooltip="include"]
"18" -> "64" [dir=forward tooltip="include"]
"64" -> "5" [dir=forward tooltip="include"]
"64" -> "20" [dir=forward tooltip="include"]
"46" -> "29" [dir=forward tooltip="include"]
"46" -> "15" [dir=forward tooltip="include"]
"46" -> "47" [dir=forward tooltip="include"]
"46" -> "48" [dir=forward tooltip="include"]
"46" -> "49" [dir=forward tooltip="include"]
"46" -> "2" [dir=forward tooltip="include"]
"46" -> "50" [dir=forward tooltip="include"]
"46" -> "16" [dir=forward tooltip="include"]
"61" -> "29" [dir=forward tooltip="include"]
"61" -> "11" [dir=forward tooltip="include"]
"61" -> "44" [dir=forward tooltip="include"]
"61" -> "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"]
"36" -> "37" [dir=forward tooltip="include"]
"36" -> "38" [dir=forward tooltip="include"]
"36" -> "39" [dir=forward tooltip="include"]
"36" -> "40" [dir=forward tooltip="include"]
"36" -> "41" [dir=forward tooltip="include"]
"33" -> "34" [dir=forward tooltip="include"]
"33" -> "21" [dir=forward tooltip="include"]
"33" -> "29" [dir=forward tooltip="include"]
"33" -> "7" [dir=forward tooltip="include"]
"33" -> "11" [dir=forward tooltip="include"]
"33" -> "32" [dir=forward tooltip="include"]
"33" -> "9" [dir=forward tooltip="include"]
"33" -> "35" [dir=forward tooltip="include"]
"33" -> "36" [dir=forward tooltip="include"]
"33" -> "42" [dir=forward tooltip="include"]
"33" -> "12" [dir=forward tooltip="include"]
"33" -> "44" [dir=forward tooltip="include"]
"33" -> "31" [dir=forward tooltip="include"]
"33" -> "45" [dir=forward tooltip="include"]
"1" -> "2" [dir=forward tooltip="include"]
"1" -> "3" [dir=forward tooltip="include"]
"1" -> "18" [dir=forward tooltip="include"]
}](_images/graphviz-4f931c81c3696bc3046700618dc8ac9d9292cda5.png)
- file UserHalo.H
- #include <Particle.H>#include <AxisymmetricBasis.H>#include <ExternalCollection.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"]
"42" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"62" [label="CenterFile.H" tooltip="CenterFile.H"]
"63" [label="Circular.H" tooltip="Circular.H"]
"28" [label="EXPException.H" tooltip="EXPException.H"]
"58" [label="Particle.H" tooltip="Particle.H"]
"55" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"50" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"52" [label="QuadLS.H" tooltip="QuadLS.H"]
"45" [label="Species.H" tooltip="Species.H"]
"13" [label="StringTok.H" tooltip="StringTok.H"]
"43" [label="Timer.H" tooltip="Timer.H"]
"14" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"49" [label="euler.H" tooltip="euler.H"]
"59" [label="gadget.H" tooltip="gadget.H"]
"54" [label="header.H" tooltip="header.H"]
"31" [label="libvars.H" tooltip="libvars.H"]
"44" [label="localmpi.H" tooltip="localmpi.H"]
"60" [label="tipsy.H" tooltip="tipsy.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"]
"64" [label="ExternalForce.H" tooltip="ExternalForce.H"]
"46" [label="Orient.H" tooltip="Orient.H"]
"61" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"5" [label="PotAccel.H" tooltip="PotAccel.H"]
"36" [label="chkTimer.H" tooltip="chkTimer.H"]
"35" [label="coef.H" tooltip="coef.H"]
"33" [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"]
"23" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"2" [label="Particle.H" tooltip="Particle.H"]
"48" [label="algorithm" tooltip="algorithm"]
"51" [label="array" tooltip="array"]
"8" [label="chrono" tooltip="chrono"]
"38" [label="cmath" tooltip="cmath"]
"16" [label="config_exp.h" tooltip="config_exp.h"]
"6" [label="cstdlib" tooltip="cstdlib"]
"47" [label="deque" tooltip="deque"]
"40" [label="fstream" tooltip="fstream"]
"27" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"25" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"26" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"24" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"41" [label="iomanip" tooltip="iomanip"]
"39" [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"]
"34" [label="pthread.h" tooltip="pthread.h"]
"32" [label="random" tooltip="random"]
"15" [label="set" tooltip="set"]
"30" [label="sstream" tooltip="sstream"]
"57" [label="stdexcept" tooltip="stdexcept"]
"7" [label="string" tooltip="string"]
"37" [label="time.h" tooltip="time.h"]
"53" [label="tuple" tooltip="tuple"]
"56" [label="unordered_map" tooltip="unordered_map"]
"22" [label="utility" tooltip="utility"]
"29" [label="vector" tooltip="vector"]
"12" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"42" -> "39" [dir=forward tooltip="include"]
"42" -> "41" [dir=forward tooltip="include"]
"42" -> "29" [dir=forward tooltip="include"]
"42" -> "7" [dir=forward tooltip="include"]
"42" -> "9" [dir=forward tooltip="include"]
"42" -> "10" [dir=forward tooltip="include"]
"42" -> "15" [dir=forward tooltip="include"]
"42" -> "11" [dir=forward tooltip="include"]
"42" -> "43" [dir=forward tooltip="include"]
"42" -> "21" [dir=forward tooltip="include"]
"62" -> "40" [dir=forward tooltip="include"]
"62" -> "29" [dir=forward tooltip="include"]
"62" -> "51" [dir=forward tooltip="include"]
"62" -> "12" [dir=forward tooltip="include"]
"63" -> "29" [dir=forward tooltip="include"]
"28" -> "15" [dir=forward tooltip="include"]
"28" -> "29" [dir=forward tooltip="include"]
"28" -> "7" [dir=forward tooltip="include"]
"28" -> "30" [dir=forward tooltip="include"]
"28" -> "31" [dir=forward tooltip="include"]
"58" -> "56" [dir=forward tooltip="include"]
"58" -> "29" [dir=forward tooltip="include"]
"58" -> "11" [dir=forward tooltip="include"]
"55" -> "56" [dir=forward tooltip="include"]
"55" -> "57" [dir=forward tooltip="include"]
"55" -> "48" [dir=forward tooltip="include"]
"55" -> "39" [dir=forward tooltip="include"]
"55" -> "40" [dir=forward tooltip="include"]
"55" -> "41" [dir=forward tooltip="include"]
"55" -> "29" [dir=forward tooltip="include"]
"55" -> "11" [dir=forward tooltip="include"]
"55" -> "7" [dir=forward tooltip="include"]
"55" -> "38" [dir=forward tooltip="include"]
"55" -> "9" [dir=forward tooltip="include"]
"55" -> "21" [dir=forward tooltip="include"]
"55" -> "16" [dir=forward tooltip="include"]
"55" -> "13" [dir=forward tooltip="include"]
"55" -> "54" [dir=forward tooltip="include"]
"55" -> "58" [dir=forward tooltip="include"]
"55" -> "59" [dir=forward tooltip="include"]
"55" -> "60" [dir=forward tooltip="include"]
"50" -> "47" [dir=forward tooltip="include"]
"50" -> "51" [dir=forward tooltip="include"]
"50" -> "17" [dir=forward tooltip="include"]
"50" -> "52" [dir=forward tooltip="include"]
"52" -> "39" [dir=forward tooltip="include"]
"52" -> "41" [dir=forward tooltip="include"]
"52" -> "53" [dir=forward tooltip="include"]
"45" -> "10" [dir=forward tooltip="include"]
"45" -> "15" [dir=forward tooltip="include"]
"45" -> "29" [dir=forward tooltip="include"]
"43" -> "39" [dir=forward tooltip="include"]
"43" -> "6" [dir=forward tooltip="include"]
"43" -> "8" [dir=forward tooltip="include"]
"14" -> "7" [dir=forward tooltip="include"]
"14" -> "15" [dir=forward tooltip="include"]
"14" -> "12" [dir=forward tooltip="include"]
"49" -> "17" [dir=forward tooltip="include"]
"54" -> "39" [dir=forward tooltip="include"]
"54" -> "41" [dir=forward tooltip="include"]
"54" -> "30" [dir=forward tooltip="include"]
"54" -> "11" [dir=forward tooltip="include"]
"54" -> "44" [dir=forward tooltip="include"]
"31" -> "32" [dir=forward tooltip="include"]
"31" -> "21" [dir=forward tooltip="include"]
"44" -> "21" [dir=forward tooltip="include"]
"44" -> "39" [dir=forward tooltip="include"]
"44" -> "40" [dir=forward tooltip="include"]
"44" -> "41" [dir=forward tooltip="include"]
"44" -> "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" -> "24" [dir=forward tooltip="include"]
"20" -> "25" [dir=forward tooltip="include"]
"20" -> "26" [dir=forward tooltip="include"]
"20" -> "27" [dir=forward tooltip="include"]
"20" -> "28" [dir=forward tooltip="include"]
"20" -> "33" [dir=forward tooltip="include"]
"20" -> "46" [dir=forward tooltip="include"]
"20" -> "54" [dir=forward tooltip="include"]
"20" -> "44" [dir=forward tooltip="include"]
"20" -> "55" [dir=forward tooltip="include"]
"20" -> "61" [dir=forward tooltip="include"]
"20" -> "62" [dir=forward tooltip="include"]
"20" -> "5" [dir=forward tooltip="include"]
"20" -> "63" [dir=forward tooltip="include"]
"20" -> "43" [dir=forward tooltip="include"]
"20" -> "16" [dir=forward tooltip="include"]
"19" -> "9" [dir=forward tooltip="include"]
"19" -> "20" [dir=forward tooltip="include"]
"19" -> "43" [dir=forward tooltip="include"]
"18" -> "10" [dir=forward tooltip="include"]
"18" -> "19" [dir=forward tooltip="include"]
"18" -> "64" [dir=forward tooltip="include"]
"64" -> "5" [dir=forward tooltip="include"]
"64" -> "20" [dir=forward tooltip="include"]
"46" -> "29" [dir=forward tooltip="include"]
"46" -> "15" [dir=forward tooltip="include"]
"46" -> "47" [dir=forward tooltip="include"]
"46" -> "48" [dir=forward tooltip="include"]
"46" -> "49" [dir=forward tooltip="include"]
"46" -> "2" [dir=forward tooltip="include"]
"46" -> "50" [dir=forward tooltip="include"]
"46" -> "16" [dir=forward tooltip="include"]
"61" -> "29" [dir=forward tooltip="include"]
"61" -> "11" [dir=forward tooltip="include"]
"61" -> "44" [dir=forward tooltip="include"]
"61" -> "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"]
"36" -> "37" [dir=forward tooltip="include"]
"36" -> "38" [dir=forward tooltip="include"]
"36" -> "39" [dir=forward tooltip="include"]
"36" -> "40" [dir=forward tooltip="include"]
"36" -> "41" [dir=forward tooltip="include"]
"33" -> "34" [dir=forward tooltip="include"]
"33" -> "21" [dir=forward tooltip="include"]
"33" -> "29" [dir=forward tooltip="include"]
"33" -> "7" [dir=forward tooltip="include"]
"33" -> "11" [dir=forward tooltip="include"]
"33" -> "32" [dir=forward tooltip="include"]
"33" -> "9" [dir=forward tooltip="include"]
"33" -> "35" [dir=forward tooltip="include"]
"33" -> "36" [dir=forward tooltip="include"]
"33" -> "42" [dir=forward tooltip="include"]
"33" -> "12" [dir=forward tooltip="include"]
"33" -> "44" [dir=forward tooltip="include"]
"33" -> "31" [dir=forward tooltip="include"]
"33" -> "45" [dir=forward tooltip="include"]
"1" -> "2" [dir=forward tooltip="include"]
"1" -> "3" [dir=forward tooltip="include"]
"1" -> "18" [dir=forward tooltip="include"]
}](_images/graphviz-74843dae1c790b6102a313411b82e34577d1cc22.png)
- file UserLogPot.H
- #include <Particle.H>#include <AxisymmetricBasis.H>#include <ExternalCollection.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"]
"42" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"62" [label="CenterFile.H" tooltip="CenterFile.H"]
"63" [label="Circular.H" tooltip="Circular.H"]
"28" [label="EXPException.H" tooltip="EXPException.H"]
"58" [label="Particle.H" tooltip="Particle.H"]
"55" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"50" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"52" [label="QuadLS.H" tooltip="QuadLS.H"]
"45" [label="Species.H" tooltip="Species.H"]
"13" [label="StringTok.H" tooltip="StringTok.H"]
"43" [label="Timer.H" tooltip="Timer.H"]
"14" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"49" [label="euler.H" tooltip="euler.H"]
"59" [label="gadget.H" tooltip="gadget.H"]
"54" [label="header.H" tooltip="header.H"]
"31" [label="libvars.H" tooltip="libvars.H"]
"44" [label="localmpi.H" tooltip="localmpi.H"]
"60" [label="tipsy.H" tooltip="tipsy.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"]
"64" [label="ExternalForce.H" tooltip="ExternalForce.H"]
"46" [label="Orient.H" tooltip="Orient.H"]
"61" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"5" [label="PotAccel.H" tooltip="PotAccel.H"]
"36" [label="chkTimer.H" tooltip="chkTimer.H"]
"35" [label="coef.H" tooltip="coef.H"]
"33" [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"]
"23" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"2" [label="Particle.H" tooltip="Particle.H"]
"48" [label="algorithm" tooltip="algorithm"]
"51" [label="array" tooltip="array"]
"8" [label="chrono" tooltip="chrono"]
"38" [label="cmath" tooltip="cmath"]
"16" [label="config_exp.h" tooltip="config_exp.h"]
"6" [label="cstdlib" tooltip="cstdlib"]
"47" [label="deque" tooltip="deque"]
"40" [label="fstream" tooltip="fstream"]
"27" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"25" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"26" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"24" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"41" [label="iomanip" tooltip="iomanip"]
"39" [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"]
"34" [label="pthread.h" tooltip="pthread.h"]
"32" [label="random" tooltip="random"]
"15" [label="set" tooltip="set"]
"30" [label="sstream" tooltip="sstream"]
"57" [label="stdexcept" tooltip="stdexcept"]
"7" [label="string" tooltip="string"]
"37" [label="time.h" tooltip="time.h"]
"53" [label="tuple" tooltip="tuple"]
"56" [label="unordered_map" tooltip="unordered_map"]
"22" [label="utility" tooltip="utility"]
"29" [label="vector" tooltip="vector"]
"12" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"42" -> "39" [dir=forward tooltip="include"]
"42" -> "41" [dir=forward tooltip="include"]
"42" -> "29" [dir=forward tooltip="include"]
"42" -> "7" [dir=forward tooltip="include"]
"42" -> "9" [dir=forward tooltip="include"]
"42" -> "10" [dir=forward tooltip="include"]
"42" -> "15" [dir=forward tooltip="include"]
"42" -> "11" [dir=forward tooltip="include"]
"42" -> "43" [dir=forward tooltip="include"]
"42" -> "21" [dir=forward tooltip="include"]
"62" -> "40" [dir=forward tooltip="include"]
"62" -> "29" [dir=forward tooltip="include"]
"62" -> "51" [dir=forward tooltip="include"]
"62" -> "12" [dir=forward tooltip="include"]
"63" -> "29" [dir=forward tooltip="include"]
"28" -> "15" [dir=forward tooltip="include"]
"28" -> "29" [dir=forward tooltip="include"]
"28" -> "7" [dir=forward tooltip="include"]
"28" -> "30" [dir=forward tooltip="include"]
"28" -> "31" [dir=forward tooltip="include"]
"58" -> "56" [dir=forward tooltip="include"]
"58" -> "29" [dir=forward tooltip="include"]
"58" -> "11" [dir=forward tooltip="include"]
"55" -> "56" [dir=forward tooltip="include"]
"55" -> "57" [dir=forward tooltip="include"]
"55" -> "48" [dir=forward tooltip="include"]
"55" -> "39" [dir=forward tooltip="include"]
"55" -> "40" [dir=forward tooltip="include"]
"55" -> "41" [dir=forward tooltip="include"]
"55" -> "29" [dir=forward tooltip="include"]
"55" -> "11" [dir=forward tooltip="include"]
"55" -> "7" [dir=forward tooltip="include"]
"55" -> "38" [dir=forward tooltip="include"]
"55" -> "9" [dir=forward tooltip="include"]
"55" -> "21" [dir=forward tooltip="include"]
"55" -> "16" [dir=forward tooltip="include"]
"55" -> "13" [dir=forward tooltip="include"]
"55" -> "54" [dir=forward tooltip="include"]
"55" -> "58" [dir=forward tooltip="include"]
"55" -> "59" [dir=forward tooltip="include"]
"55" -> "60" [dir=forward tooltip="include"]
"50" -> "47" [dir=forward tooltip="include"]
"50" -> "51" [dir=forward tooltip="include"]
"50" -> "17" [dir=forward tooltip="include"]
"50" -> "52" [dir=forward tooltip="include"]
"52" -> "39" [dir=forward tooltip="include"]
"52" -> "41" [dir=forward tooltip="include"]
"52" -> "53" [dir=forward tooltip="include"]
"45" -> "10" [dir=forward tooltip="include"]
"45" -> "15" [dir=forward tooltip="include"]
"45" -> "29" [dir=forward tooltip="include"]
"43" -> "39" [dir=forward tooltip="include"]
"43" -> "6" [dir=forward tooltip="include"]
"43" -> "8" [dir=forward tooltip="include"]
"14" -> "7" [dir=forward tooltip="include"]
"14" -> "15" [dir=forward tooltip="include"]
"14" -> "12" [dir=forward tooltip="include"]
"49" -> "17" [dir=forward tooltip="include"]
"54" -> "39" [dir=forward tooltip="include"]
"54" -> "41" [dir=forward tooltip="include"]
"54" -> "30" [dir=forward tooltip="include"]
"54" -> "11" [dir=forward tooltip="include"]
"54" -> "44" [dir=forward tooltip="include"]
"31" -> "32" [dir=forward tooltip="include"]
"31" -> "21" [dir=forward tooltip="include"]
"44" -> "21" [dir=forward tooltip="include"]
"44" -> "39" [dir=forward tooltip="include"]
"44" -> "40" [dir=forward tooltip="include"]
"44" -> "41" [dir=forward tooltip="include"]
"44" -> "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" -> "24" [dir=forward tooltip="include"]
"20" -> "25" [dir=forward tooltip="include"]
"20" -> "26" [dir=forward tooltip="include"]
"20" -> "27" [dir=forward tooltip="include"]
"20" -> "28" [dir=forward tooltip="include"]
"20" -> "33" [dir=forward tooltip="include"]
"20" -> "46" [dir=forward tooltip="include"]
"20" -> "54" [dir=forward tooltip="include"]
"20" -> "44" [dir=forward tooltip="include"]
"20" -> "55" [dir=forward tooltip="include"]
"20" -> "61" [dir=forward tooltip="include"]
"20" -> "62" [dir=forward tooltip="include"]
"20" -> "5" [dir=forward tooltip="include"]
"20" -> "63" [dir=forward tooltip="include"]
"20" -> "43" [dir=forward tooltip="include"]
"20" -> "16" [dir=forward tooltip="include"]
"19" -> "9" [dir=forward tooltip="include"]
"19" -> "20" [dir=forward tooltip="include"]
"19" -> "43" [dir=forward tooltip="include"]
"18" -> "10" [dir=forward tooltip="include"]
"18" -> "19" [dir=forward tooltip="include"]
"18" -> "64" [dir=forward tooltip="include"]
"64" -> "5" [dir=forward tooltip="include"]
"64" -> "20" [dir=forward tooltip="include"]
"46" -> "29" [dir=forward tooltip="include"]
"46" -> "15" [dir=forward tooltip="include"]
"46" -> "47" [dir=forward tooltip="include"]
"46" -> "48" [dir=forward tooltip="include"]
"46" -> "49" [dir=forward tooltip="include"]
"46" -> "2" [dir=forward tooltip="include"]
"46" -> "50" [dir=forward tooltip="include"]
"46" -> "16" [dir=forward tooltip="include"]
"61" -> "29" [dir=forward tooltip="include"]
"61" -> "11" [dir=forward tooltip="include"]
"61" -> "44" [dir=forward tooltip="include"]
"61" -> "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"]
"36" -> "37" [dir=forward tooltip="include"]
"36" -> "38" [dir=forward tooltip="include"]
"36" -> "39" [dir=forward tooltip="include"]
"36" -> "40" [dir=forward tooltip="include"]
"36" -> "41" [dir=forward tooltip="include"]
"33" -> "34" [dir=forward tooltip="include"]
"33" -> "21" [dir=forward tooltip="include"]
"33" -> "29" [dir=forward tooltip="include"]
"33" -> "7" [dir=forward tooltip="include"]
"33" -> "11" [dir=forward tooltip="include"]
"33" -> "32" [dir=forward tooltip="include"]
"33" -> "9" [dir=forward tooltip="include"]
"33" -> "35" [dir=forward tooltip="include"]
"33" -> "36" [dir=forward tooltip="include"]
"33" -> "42" [dir=forward tooltip="include"]
"33" -> "12" [dir=forward tooltip="include"]
"33" -> "44" [dir=forward tooltip="include"]
"33" -> "31" [dir=forward tooltip="include"]
"33" -> "45" [dir=forward tooltip="include"]
"1" -> "2" [dir=forward tooltip="include"]
"1" -> "3" [dir=forward tooltip="include"]
"1" -> "18" [dir=forward tooltip="include"]
}](_images/graphviz-3e5bfc86ff1ad687c786137c2d1722bb80576952.png)
- file UserMNdisk.H
- #include <Particle.H>#include <AxisymmetricBasis.H>#include <ExternalCollection.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"]
"42" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"62" [label="CenterFile.H" tooltip="CenterFile.H"]
"63" [label="Circular.H" tooltip="Circular.H"]
"28" [label="EXPException.H" tooltip="EXPException.H"]
"58" [label="Particle.H" tooltip="Particle.H"]
"55" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"50" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"52" [label="QuadLS.H" tooltip="QuadLS.H"]
"45" [label="Species.H" tooltip="Species.H"]
"13" [label="StringTok.H" tooltip="StringTok.H"]
"43" [label="Timer.H" tooltip="Timer.H"]
"14" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"49" [label="euler.H" tooltip="euler.H"]
"59" [label="gadget.H" tooltip="gadget.H"]
"54" [label="header.H" tooltip="header.H"]
"31" [label="libvars.H" tooltip="libvars.H"]
"44" [label="localmpi.H" tooltip="localmpi.H"]
"60" [label="tipsy.H" tooltip="tipsy.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"]
"64" [label="ExternalForce.H" tooltip="ExternalForce.H"]
"46" [label="Orient.H" tooltip="Orient.H"]
"61" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"5" [label="PotAccel.H" tooltip="PotAccel.H"]
"36" [label="chkTimer.H" tooltip="chkTimer.H"]
"35" [label="coef.H" tooltip="coef.H"]
"33" [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"]
"23" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"2" [label="Particle.H" tooltip="Particle.H"]
"48" [label="algorithm" tooltip="algorithm"]
"51" [label="array" tooltip="array"]
"8" [label="chrono" tooltip="chrono"]
"38" [label="cmath" tooltip="cmath"]
"16" [label="config_exp.h" tooltip="config_exp.h"]
"6" [label="cstdlib" tooltip="cstdlib"]
"47" [label="deque" tooltip="deque"]
"40" [label="fstream" tooltip="fstream"]
"27" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"25" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"26" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"24" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"41" [label="iomanip" tooltip="iomanip"]
"39" [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"]
"34" [label="pthread.h" tooltip="pthread.h"]
"32" [label="random" tooltip="random"]
"15" [label="set" tooltip="set"]
"30" [label="sstream" tooltip="sstream"]
"57" [label="stdexcept" tooltip="stdexcept"]
"7" [label="string" tooltip="string"]
"37" [label="time.h" tooltip="time.h"]
"53" [label="tuple" tooltip="tuple"]
"56" [label="unordered_map" tooltip="unordered_map"]
"22" [label="utility" tooltip="utility"]
"29" [label="vector" tooltip="vector"]
"12" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"42" -> "39" [dir=forward tooltip="include"]
"42" -> "41" [dir=forward tooltip="include"]
"42" -> "29" [dir=forward tooltip="include"]
"42" -> "7" [dir=forward tooltip="include"]
"42" -> "9" [dir=forward tooltip="include"]
"42" -> "10" [dir=forward tooltip="include"]
"42" -> "15" [dir=forward tooltip="include"]
"42" -> "11" [dir=forward tooltip="include"]
"42" -> "43" [dir=forward tooltip="include"]
"42" -> "21" [dir=forward tooltip="include"]
"62" -> "40" [dir=forward tooltip="include"]
"62" -> "29" [dir=forward tooltip="include"]
"62" -> "51" [dir=forward tooltip="include"]
"62" -> "12" [dir=forward tooltip="include"]
"63" -> "29" [dir=forward tooltip="include"]
"28" -> "15" [dir=forward tooltip="include"]
"28" -> "29" [dir=forward tooltip="include"]
"28" -> "7" [dir=forward tooltip="include"]
"28" -> "30" [dir=forward tooltip="include"]
"28" -> "31" [dir=forward tooltip="include"]
"58" -> "56" [dir=forward tooltip="include"]
"58" -> "29" [dir=forward tooltip="include"]
"58" -> "11" [dir=forward tooltip="include"]
"55" -> "56" [dir=forward tooltip="include"]
"55" -> "57" [dir=forward tooltip="include"]
"55" -> "48" [dir=forward tooltip="include"]
"55" -> "39" [dir=forward tooltip="include"]
"55" -> "40" [dir=forward tooltip="include"]
"55" -> "41" [dir=forward tooltip="include"]
"55" -> "29" [dir=forward tooltip="include"]
"55" -> "11" [dir=forward tooltip="include"]
"55" -> "7" [dir=forward tooltip="include"]
"55" -> "38" [dir=forward tooltip="include"]
"55" -> "9" [dir=forward tooltip="include"]
"55" -> "21" [dir=forward tooltip="include"]
"55" -> "16" [dir=forward tooltip="include"]
"55" -> "13" [dir=forward tooltip="include"]
"55" -> "54" [dir=forward tooltip="include"]
"55" -> "58" [dir=forward tooltip="include"]
"55" -> "59" [dir=forward tooltip="include"]
"55" -> "60" [dir=forward tooltip="include"]
"50" -> "47" [dir=forward tooltip="include"]
"50" -> "51" [dir=forward tooltip="include"]
"50" -> "17" [dir=forward tooltip="include"]
"50" -> "52" [dir=forward tooltip="include"]
"52" -> "39" [dir=forward tooltip="include"]
"52" -> "41" [dir=forward tooltip="include"]
"52" -> "53" [dir=forward tooltip="include"]
"45" -> "10" [dir=forward tooltip="include"]
"45" -> "15" [dir=forward tooltip="include"]
"45" -> "29" [dir=forward tooltip="include"]
"43" -> "39" [dir=forward tooltip="include"]
"43" -> "6" [dir=forward tooltip="include"]
"43" -> "8" [dir=forward tooltip="include"]
"14" -> "7" [dir=forward tooltip="include"]
"14" -> "15" [dir=forward tooltip="include"]
"14" -> "12" [dir=forward tooltip="include"]
"49" -> "17" [dir=forward tooltip="include"]
"54" -> "39" [dir=forward tooltip="include"]
"54" -> "41" [dir=forward tooltip="include"]
"54" -> "30" [dir=forward tooltip="include"]
"54" -> "11" [dir=forward tooltip="include"]
"54" -> "44" [dir=forward tooltip="include"]
"31" -> "32" [dir=forward tooltip="include"]
"31" -> "21" [dir=forward tooltip="include"]
"44" -> "21" [dir=forward tooltip="include"]
"44" -> "39" [dir=forward tooltip="include"]
"44" -> "40" [dir=forward tooltip="include"]
"44" -> "41" [dir=forward tooltip="include"]
"44" -> "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" -> "24" [dir=forward tooltip="include"]
"20" -> "25" [dir=forward tooltip="include"]
"20" -> "26" [dir=forward tooltip="include"]
"20" -> "27" [dir=forward tooltip="include"]
"20" -> "28" [dir=forward tooltip="include"]
"20" -> "33" [dir=forward tooltip="include"]
"20" -> "46" [dir=forward tooltip="include"]
"20" -> "54" [dir=forward tooltip="include"]
"20" -> "44" [dir=forward tooltip="include"]
"20" -> "55" [dir=forward tooltip="include"]
"20" -> "61" [dir=forward tooltip="include"]
"20" -> "62" [dir=forward tooltip="include"]
"20" -> "5" [dir=forward tooltip="include"]
"20" -> "63" [dir=forward tooltip="include"]
"20" -> "43" [dir=forward tooltip="include"]
"20" -> "16" [dir=forward tooltip="include"]
"19" -> "9" [dir=forward tooltip="include"]
"19" -> "20" [dir=forward tooltip="include"]
"19" -> "43" [dir=forward tooltip="include"]
"18" -> "10" [dir=forward tooltip="include"]
"18" -> "19" [dir=forward tooltip="include"]
"18" -> "64" [dir=forward tooltip="include"]
"64" -> "5" [dir=forward tooltip="include"]
"64" -> "20" [dir=forward tooltip="include"]
"46" -> "29" [dir=forward tooltip="include"]
"46" -> "15" [dir=forward tooltip="include"]
"46" -> "47" [dir=forward tooltip="include"]
"46" -> "48" [dir=forward tooltip="include"]
"46" -> "49" [dir=forward tooltip="include"]
"46" -> "2" [dir=forward tooltip="include"]
"46" -> "50" [dir=forward tooltip="include"]
"46" -> "16" [dir=forward tooltip="include"]
"61" -> "29" [dir=forward tooltip="include"]
"61" -> "11" [dir=forward tooltip="include"]
"61" -> "44" [dir=forward tooltip="include"]
"61" -> "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"]
"36" -> "37" [dir=forward tooltip="include"]
"36" -> "38" [dir=forward tooltip="include"]
"36" -> "39" [dir=forward tooltip="include"]
"36" -> "40" [dir=forward tooltip="include"]
"36" -> "41" [dir=forward tooltip="include"]
"33" -> "34" [dir=forward tooltip="include"]
"33" -> "21" [dir=forward tooltip="include"]
"33" -> "29" [dir=forward tooltip="include"]
"33" -> "7" [dir=forward tooltip="include"]
"33" -> "11" [dir=forward tooltip="include"]
"33" -> "32" [dir=forward tooltip="include"]
"33" -> "9" [dir=forward tooltip="include"]
"33" -> "35" [dir=forward tooltip="include"]
"33" -> "36" [dir=forward tooltip="include"]
"33" -> "42" [dir=forward tooltip="include"]
"33" -> "12" [dir=forward tooltip="include"]
"33" -> "44" [dir=forward tooltip="include"]
"33" -> "31" [dir=forward tooltip="include"]
"33" -> "45" [dir=forward tooltip="include"]
"1" -> "2" [dir=forward tooltip="include"]
"1" -> "3" [dir=forward tooltip="include"]
"1" -> "18" [dir=forward tooltip="include"]
}](_images/graphviz-baae06e395a4530e11b336e9aff9e4542ae95d0e.png)
- file UserMW.H
- #include <Particle.H>#include <AxisymmetricBasis.H>#include <ExternalCollection.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"]
"42" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"62" [label="CenterFile.H" tooltip="CenterFile.H"]
"63" [label="Circular.H" tooltip="Circular.H"]
"28" [label="EXPException.H" tooltip="EXPException.H"]
"58" [label="Particle.H" tooltip="Particle.H"]
"55" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"50" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"52" [label="QuadLS.H" tooltip="QuadLS.H"]
"45" [label="Species.H" tooltip="Species.H"]
"13" [label="StringTok.H" tooltip="StringTok.H"]
"43" [label="Timer.H" tooltip="Timer.H"]
"14" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"49" [label="euler.H" tooltip="euler.H"]
"59" [label="gadget.H" tooltip="gadget.H"]
"54" [label="header.H" tooltip="header.H"]
"31" [label="libvars.H" tooltip="libvars.H"]
"44" [label="localmpi.H" tooltip="localmpi.H"]
"60" [label="tipsy.H" tooltip="tipsy.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"]
"64" [label="ExternalForce.H" tooltip="ExternalForce.H"]
"46" [label="Orient.H" tooltip="Orient.H"]
"61" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"5" [label="PotAccel.H" tooltip="PotAccel.H"]
"36" [label="chkTimer.H" tooltip="chkTimer.H"]
"35" [label="coef.H" tooltip="coef.H"]
"33" [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"]
"23" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"2" [label="Particle.H" tooltip="Particle.H"]
"48" [label="algorithm" tooltip="algorithm"]
"51" [label="array" tooltip="array"]
"8" [label="chrono" tooltip="chrono"]
"38" [label="cmath" tooltip="cmath"]
"16" [label="config_exp.h" tooltip="config_exp.h"]
"6" [label="cstdlib" tooltip="cstdlib"]
"47" [label="deque" tooltip="deque"]
"40" [label="fstream" tooltip="fstream"]
"27" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"25" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"26" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"24" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"41" [label="iomanip" tooltip="iomanip"]
"39" [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"]
"34" [label="pthread.h" tooltip="pthread.h"]
"32" [label="random" tooltip="random"]
"15" [label="set" tooltip="set"]
"30" [label="sstream" tooltip="sstream"]
"57" [label="stdexcept" tooltip="stdexcept"]
"7" [label="string" tooltip="string"]
"37" [label="time.h" tooltip="time.h"]
"53" [label="tuple" tooltip="tuple"]
"56" [label="unordered_map" tooltip="unordered_map"]
"22" [label="utility" tooltip="utility"]
"29" [label="vector" tooltip="vector"]
"12" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"42" -> "39" [dir=forward tooltip="include"]
"42" -> "41" [dir=forward tooltip="include"]
"42" -> "29" [dir=forward tooltip="include"]
"42" -> "7" [dir=forward tooltip="include"]
"42" -> "9" [dir=forward tooltip="include"]
"42" -> "10" [dir=forward tooltip="include"]
"42" -> "15" [dir=forward tooltip="include"]
"42" -> "11" [dir=forward tooltip="include"]
"42" -> "43" [dir=forward tooltip="include"]
"42" -> "21" [dir=forward tooltip="include"]
"62" -> "40" [dir=forward tooltip="include"]
"62" -> "29" [dir=forward tooltip="include"]
"62" -> "51" [dir=forward tooltip="include"]
"62" -> "12" [dir=forward tooltip="include"]
"63" -> "29" [dir=forward tooltip="include"]
"28" -> "15" [dir=forward tooltip="include"]
"28" -> "29" [dir=forward tooltip="include"]
"28" -> "7" [dir=forward tooltip="include"]
"28" -> "30" [dir=forward tooltip="include"]
"28" -> "31" [dir=forward tooltip="include"]
"58" -> "56" [dir=forward tooltip="include"]
"58" -> "29" [dir=forward tooltip="include"]
"58" -> "11" [dir=forward tooltip="include"]
"55" -> "56" [dir=forward tooltip="include"]
"55" -> "57" [dir=forward tooltip="include"]
"55" -> "48" [dir=forward tooltip="include"]
"55" -> "39" [dir=forward tooltip="include"]
"55" -> "40" [dir=forward tooltip="include"]
"55" -> "41" [dir=forward tooltip="include"]
"55" -> "29" [dir=forward tooltip="include"]
"55" -> "11" [dir=forward tooltip="include"]
"55" -> "7" [dir=forward tooltip="include"]
"55" -> "38" [dir=forward tooltip="include"]
"55" -> "9" [dir=forward tooltip="include"]
"55" -> "21" [dir=forward tooltip="include"]
"55" -> "16" [dir=forward tooltip="include"]
"55" -> "13" [dir=forward tooltip="include"]
"55" -> "54" [dir=forward tooltip="include"]
"55" -> "58" [dir=forward tooltip="include"]
"55" -> "59" [dir=forward tooltip="include"]
"55" -> "60" [dir=forward tooltip="include"]
"50" -> "47" [dir=forward tooltip="include"]
"50" -> "51" [dir=forward tooltip="include"]
"50" -> "17" [dir=forward tooltip="include"]
"50" -> "52" [dir=forward tooltip="include"]
"52" -> "39" [dir=forward tooltip="include"]
"52" -> "41" [dir=forward tooltip="include"]
"52" -> "53" [dir=forward tooltip="include"]
"45" -> "10" [dir=forward tooltip="include"]
"45" -> "15" [dir=forward tooltip="include"]
"45" -> "29" [dir=forward tooltip="include"]
"43" -> "39" [dir=forward tooltip="include"]
"43" -> "6" [dir=forward tooltip="include"]
"43" -> "8" [dir=forward tooltip="include"]
"14" -> "7" [dir=forward tooltip="include"]
"14" -> "15" [dir=forward tooltip="include"]
"14" -> "12" [dir=forward tooltip="include"]
"49" -> "17" [dir=forward tooltip="include"]
"54" -> "39" [dir=forward tooltip="include"]
"54" -> "41" [dir=forward tooltip="include"]
"54" -> "30" [dir=forward tooltip="include"]
"54" -> "11" [dir=forward tooltip="include"]
"54" -> "44" [dir=forward tooltip="include"]
"31" -> "32" [dir=forward tooltip="include"]
"31" -> "21" [dir=forward tooltip="include"]
"44" -> "21" [dir=forward tooltip="include"]
"44" -> "39" [dir=forward tooltip="include"]
"44" -> "40" [dir=forward tooltip="include"]
"44" -> "41" [dir=forward tooltip="include"]
"44" -> "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" -> "24" [dir=forward tooltip="include"]
"20" -> "25" [dir=forward tooltip="include"]
"20" -> "26" [dir=forward tooltip="include"]
"20" -> "27" [dir=forward tooltip="include"]
"20" -> "28" [dir=forward tooltip="include"]
"20" -> "33" [dir=forward tooltip="include"]
"20" -> "46" [dir=forward tooltip="include"]
"20" -> "54" [dir=forward tooltip="include"]
"20" -> "44" [dir=forward tooltip="include"]
"20" -> "55" [dir=forward tooltip="include"]
"20" -> "61" [dir=forward tooltip="include"]
"20" -> "62" [dir=forward tooltip="include"]
"20" -> "5" [dir=forward tooltip="include"]
"20" -> "63" [dir=forward tooltip="include"]
"20" -> "43" [dir=forward tooltip="include"]
"20" -> "16" [dir=forward tooltip="include"]
"19" -> "9" [dir=forward tooltip="include"]
"19" -> "20" [dir=forward tooltip="include"]
"19" -> "43" [dir=forward tooltip="include"]
"18" -> "10" [dir=forward tooltip="include"]
"18" -> "19" [dir=forward tooltip="include"]
"18" -> "64" [dir=forward tooltip="include"]
"64" -> "5" [dir=forward tooltip="include"]
"64" -> "20" [dir=forward tooltip="include"]
"46" -> "29" [dir=forward tooltip="include"]
"46" -> "15" [dir=forward tooltip="include"]
"46" -> "47" [dir=forward tooltip="include"]
"46" -> "48" [dir=forward tooltip="include"]
"46" -> "49" [dir=forward tooltip="include"]
"46" -> "2" [dir=forward tooltip="include"]
"46" -> "50" [dir=forward tooltip="include"]
"46" -> "16" [dir=forward tooltip="include"]
"61" -> "29" [dir=forward tooltip="include"]
"61" -> "11" [dir=forward tooltip="include"]
"61" -> "44" [dir=forward tooltip="include"]
"61" -> "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"]
"36" -> "37" [dir=forward tooltip="include"]
"36" -> "38" [dir=forward tooltip="include"]
"36" -> "39" [dir=forward tooltip="include"]
"36" -> "40" [dir=forward tooltip="include"]
"36" -> "41" [dir=forward tooltip="include"]
"33" -> "34" [dir=forward tooltip="include"]
"33" -> "21" [dir=forward tooltip="include"]
"33" -> "29" [dir=forward tooltip="include"]
"33" -> "7" [dir=forward tooltip="include"]
"33" -> "11" [dir=forward tooltip="include"]
"33" -> "32" [dir=forward tooltip="include"]
"33" -> "9" [dir=forward tooltip="include"]
"33" -> "35" [dir=forward tooltip="include"]
"33" -> "36" [dir=forward tooltip="include"]
"33" -> "42" [dir=forward tooltip="include"]
"33" -> "12" [dir=forward tooltip="include"]
"33" -> "44" [dir=forward tooltip="include"]
"33" -> "31" [dir=forward tooltip="include"]
"33" -> "45" [dir=forward tooltip="include"]
"1" -> "2" [dir=forward tooltip="include"]
"1" -> "3" [dir=forward tooltip="include"]
"1" -> "18" [dir=forward tooltip="include"]
}](_images/graphviz-07281fcd1263086791ae2f96dccd4c7bf48146da.png)
- file UserTest.H
- #include <ExternalCollection.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"]
"32" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"58" [label="CenterFile.H" tooltip="CenterFile.H"]
"61" [label="Circular.H" tooltip="Circular.H"]
"15" [label="EXPException.H" tooltip="EXPException.H"]
"54" [label="Particle.H" tooltip="Particle.H"]
"50" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"44" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"46" [label="QuadLS.H" tooltip="QuadLS.H"]
"37" [label="Species.H" tooltip="Species.H"]
"53" [label="StringTok.H" tooltip="StringTok.H"]
"33" [label="Timer.H" tooltip="Timer.H"]
"60" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"41" [label="euler.H" tooltip="euler.H"]
"55" [label="gadget.H" tooltip="gadget.H"]
"49" [label="header.H" tooltip="header.H"]
"20" [label="libvars.H" tooltip="libvars.H"]
"36" [label="localmpi.H" tooltip="localmpi.H"]
"56" [label="tipsy.H" tooltip="tipsy.H"]
"6" [label="Component.H" tooltip="Component.H"]
"4" [label="ComponentContainer.H" tooltip="ComponentContainer.H"]
"2" [label="ExternalCollection.H" tooltip="ExternalCollection.H"]
"62" [label="ExternalForce.H" tooltip="ExternalForce.H"]
"38" [label="Orient.H" tooltip="Orient.H"]
"57" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"59" [label="PotAccel.H" tooltip="PotAccel.H"]
"26" [label="chkTimer.H" tooltip="chkTimer.H"]
"25" [label="coef.H" tooltip="coef.H"]
"22" [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"]
"42" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"10" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"43" [label="Particle.H" tooltip="Particle.H"]
"40" [label="algorithm" tooltip="algorithm"]
"45" [label="array" tooltip="array"]
"35" [label="chrono" tooltip="chrono"]
"28" [label="cmath" tooltip="cmath"]
"48" [label="config_exp.h" tooltip="config_exp.h"]
"34" [label="cstdlib" tooltip="cstdlib"]
"39" [label="deque" tooltip="deque"]
"30" [label="fstream" tooltip="fstream"]
"14" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"12" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"13" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"11" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"31" [label="iomanip" tooltip="iomanip"]
"29" [label="iostream" tooltip="iostream"]
"5" [label="list" tooltip="list"]
"3" [label="map" tooltip="map"]
"24" [label="memory" tooltip="memory"]
"7" [label="mpi.h" tooltip="mpi.h"]
"23" [label="pthread.h" tooltip="pthread.h"]
"21" [label="random" tooltip="random"]
"16" [label="set" tooltip="set"]
"19" [label="sstream" tooltip="sstream"]
"52" [label="stdexcept" tooltip="stdexcept"]
"18" [label="string" tooltip="string"]
"27" [label="time.h" tooltip="time.h"]
"47" [label="tuple" tooltip="tuple"]
"51" [label="unordered_map" tooltip="unordered_map"]
"8" [label="utility" tooltip="utility"]
"17" [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" -> "17" [dir=forward tooltip="include"]
"32" -> "18" [dir=forward tooltip="include"]
"32" -> "5" [dir=forward tooltip="include"]
"32" -> "3" [dir=forward tooltip="include"]
"32" -> "16" [dir=forward tooltip="include"]
"32" -> "24" [dir=forward tooltip="include"]
"32" -> "33" [dir=forward tooltip="include"]
"32" -> "7" [dir=forward tooltip="include"]
"58" -> "30" [dir=forward tooltip="include"]
"58" -> "17" [dir=forward tooltip="include"]
"58" -> "45" [dir=forward tooltip="include"]
"58" -> "9" [dir=forward tooltip="include"]
"61" -> "17" [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" -> "20" [dir=forward tooltip="include"]
"54" -> "51" [dir=forward tooltip="include"]
"54" -> "17" [dir=forward tooltip="include"]
"54" -> "24" [dir=forward tooltip="include"]
"50" -> "51" [dir=forward tooltip="include"]
"50" -> "52" [dir=forward tooltip="include"]
"50" -> "40" [dir=forward tooltip="include"]
"50" -> "29" [dir=forward tooltip="include"]
"50" -> "30" [dir=forward tooltip="include"]
"50" -> "31" [dir=forward tooltip="include"]
"50" -> "17" [dir=forward tooltip="include"]
"50" -> "24" [dir=forward tooltip="include"]
"50" -> "18" [dir=forward tooltip="include"]
"50" -> "28" [dir=forward tooltip="include"]
"50" -> "5" [dir=forward tooltip="include"]
"50" -> "7" [dir=forward tooltip="include"]
"50" -> "48" [dir=forward tooltip="include"]
"50" -> "53" [dir=forward tooltip="include"]
"50" -> "49" [dir=forward tooltip="include"]
"50" -> "54" [dir=forward tooltip="include"]
"50" -> "55" [dir=forward tooltip="include"]
"50" -> "56" [dir=forward tooltip="include"]
"44" -> "39" [dir=forward tooltip="include"]
"44" -> "45" [dir=forward tooltip="include"]
"44" -> "42" [dir=forward tooltip="include"]
"44" -> "46" [dir=forward tooltip="include"]
"46" -> "29" [dir=forward tooltip="include"]
"46" -> "31" [dir=forward tooltip="include"]
"46" -> "47" [dir=forward tooltip="include"]
"37" -> "3" [dir=forward tooltip="include"]
"37" -> "16" [dir=forward tooltip="include"]
"37" -> "17" [dir=forward tooltip="include"]
"33" -> "29" [dir=forward tooltip="include"]
"33" -> "34" [dir=forward tooltip="include"]
"33" -> "35" [dir=forward tooltip="include"]
"60" -> "18" [dir=forward tooltip="include"]
"60" -> "16" [dir=forward tooltip="include"]
"60" -> "9" [dir=forward tooltip="include"]
"41" -> "42" [dir=forward tooltip="include"]
"49" -> "29" [dir=forward tooltip="include"]
"49" -> "31" [dir=forward tooltip="include"]
"49" -> "19" [dir=forward tooltip="include"]
"49" -> "24" [dir=forward tooltip="include"]
"49" -> "36" [dir=forward tooltip="include"]
"20" -> "21" [dir=forward tooltip="include"]
"20" -> "7" [dir=forward tooltip="include"]
"36" -> "7" [dir=forward tooltip="include"]
"36" -> "29" [dir=forward tooltip="include"]
"36" -> "30" [dir=forward tooltip="include"]
"36" -> "31" [dir=forward tooltip="include"]
"36" -> "18" [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" -> "14" [dir=forward tooltip="include"]
"6" -> "15" [dir=forward tooltip="include"]
"6" -> "22" [dir=forward tooltip="include"]
"6" -> "38" [dir=forward tooltip="include"]
"6" -> "49" [dir=forward tooltip="include"]
"6" -> "36" [dir=forward tooltip="include"]
"6" -> "50" [dir=forward tooltip="include"]
"6" -> "57" [dir=forward tooltip="include"]
"6" -> "58" [dir=forward tooltip="include"]
"6" -> "59" [dir=forward tooltip="include"]
"6" -> "61" [dir=forward tooltip="include"]
"6" -> "33" [dir=forward tooltip="include"]
"6" -> "48" [dir=forward tooltip="include"]
"4" -> "5" [dir=forward tooltip="include"]
"4" -> "6" [dir=forward tooltip="include"]
"4" -> "33" [dir=forward tooltip="include"]
"2" -> "3" [dir=forward tooltip="include"]
"2" -> "4" [dir=forward tooltip="include"]
"2" -> "62" [dir=forward tooltip="include"]
"62" -> "59" [dir=forward tooltip="include"]
"62" -> "6" [dir=forward tooltip="include"]
"38" -> "17" [dir=forward tooltip="include"]
"38" -> "16" [dir=forward tooltip="include"]
"38" -> "39" [dir=forward tooltip="include"]
"38" -> "40" [dir=forward tooltip="include"]
"38" -> "41" [dir=forward tooltip="include"]
"38" -> "43" [dir=forward tooltip="include"]
"38" -> "44" [dir=forward tooltip="include"]
"38" -> "48" [dir=forward tooltip="include"]
"57" -> "17" [dir=forward tooltip="include"]
"57" -> "24" [dir=forward tooltip="include"]
"57" -> "36" [dir=forward tooltip="include"]
"57" -> "43" [dir=forward tooltip="include"]
"59" -> "34" [dir=forward tooltip="include"]
"59" -> "18" [dir=forward tooltip="include"]
"59" -> "35" [dir=forward tooltip="include"]
"59" -> "5" [dir=forward tooltip="include"]
"59" -> "3" [dir=forward tooltip="include"]
"59" -> "24" [dir=forward tooltip="include"]
"59" -> "9" [dir=forward tooltip="include"]
"59" -> "43" [dir=forward tooltip="include"]
"59" -> "53" [dir=forward tooltip="include"]
"59" -> "60" [dir=forward tooltip="include"]
"59" -> "48" [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"]
"22" -> "23" [dir=forward tooltip="include"]
"22" -> "7" [dir=forward tooltip="include"]
"22" -> "17" [dir=forward tooltip="include"]
"22" -> "18" [dir=forward tooltip="include"]
"22" -> "24" [dir=forward tooltip="include"]
"22" -> "21" [dir=forward tooltip="include"]
"22" -> "5" [dir=forward tooltip="include"]
"22" -> "25" [dir=forward tooltip="include"]
"22" -> "26" [dir=forward tooltip="include"]
"22" -> "32" [dir=forward tooltip="include"]
"22" -> "9" [dir=forward tooltip="include"]
"22" -> "36" [dir=forward tooltip="include"]
"22" -> "20" [dir=forward tooltip="include"]
"22" -> "37" [dir=forward tooltip="include"]
"1" -> "2" [dir=forward tooltip="include"]
}](_images/graphviz-43bcc488c3f50eed4357c15e8c7d9dca952a675e.png)
- 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"]
"38" [label="BarrierWrapper.H" tooltip="BarrierWrapper.H"]
"59" [label="CenterFile.H" tooltip="CenterFile.H"]
"60" [label="Circular.H" tooltip="Circular.H"]
"24" [label="EXPException.H" tooltip="EXPException.H"]
"55" [label="Particle.H" tooltip="Particle.H"]
"52" [label="ParticleReader.H" tooltip="ParticleReader.H"]
"47" [label="PseudoAccel.H" tooltip="PseudoAccel.H"]
"49" [label="QuadLS.H" tooltip="QuadLS.H"]
"41" [label="Species.H" tooltip="Species.H"]
"12" [label="StringTok.H" tooltip="StringTok.H"]
"39" [label="Timer.H" tooltip="Timer.H"]
"13" [label="YamlCheck.H" tooltip="YamlCheck.H"]
"45" [label="euler.H" tooltip="euler.H"]
"56" [label="gadget.H" tooltip="gadget.H"]
"51" [label="header.H" tooltip="header.H"]
"27" [label="libvars.H" tooltip="libvars.H"]
"40" [label="localmpi.H" tooltip="localmpi.H"]
"57" [label="tipsy.H" tooltip="tipsy.H"]
"16" [label="Component.H" tooltip="Component.H"]
"2" [label="ExternalForce.H" tooltip="ExternalForce.H"]
"42" [label="Orient.H" tooltip="Orient.H"]
"58" [label="ParticleFerry.H" tooltip="ParticleFerry.H"]
"3" [label="PotAccel.H" tooltip="PotAccel.H"]
"32" [label="chkTimer.H" tooltip="chkTimer.H"]
"31" [label="coef.H" tooltip="coef.H"]
"29" [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"]
"46" [label="Eigen/Eigen" tooltip="Eigen/Eigen"]
"19" [label="H5Cpp.h" tooltip="H5Cpp.h"]
"11" [label="Particle.H" tooltip="Particle.H"]
"44" [label="algorithm" tooltip="algorithm"]
"48" [label="array" tooltip="array"]
"6" [label="chrono" tooltip="chrono"]
"34" [label="cmath" tooltip="cmath"]
"15" [label="config_exp.h" tooltip="config_exp.h"]
"4" [label="cstdlib" tooltip="cstdlib"]
"43" [label="deque" tooltip="deque"]
"36" [label="fstream" tooltip="fstream"]
"23" [label="highfive/H5Attribute.hpp" tooltip="highfive/H5Attribute.hpp"]
"21" [label="highfive/H5DataSet.hpp" tooltip="highfive/H5DataSet.hpp"]
"22" [label="highfive/H5DataSpace.hpp" tooltip="highfive/H5DataSpace.hpp"]
"20" [label="highfive/H5File.hpp" tooltip="highfive/H5File.hpp"]
"37" [label="iomanip" tooltip="iomanip"]
"35" [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"]
"30" [label="pthread.h" tooltip="pthread.h"]
"28" [label="random" tooltip="random"]
"14" [label="set" tooltip="set"]
"26" [label="sstream" tooltip="sstream"]
"54" [label="stdexcept" tooltip="stdexcept"]
"5" [label="string" tooltip="string"]
"33" [label="time.h" tooltip="time.h"]
"50" [label="tuple" tooltip="tuple"]
"53" [label="unordered_map" tooltip="unordered_map"]
"18" [label="utility" tooltip="utility"]
"25" [label="vector" tooltip="vector"]
"10" [label="yaml-cpp/yaml.h" tooltip="yaml-cpp/yaml.h"]
"38" -> "35" [dir=forward tooltip="include"]
"38" -> "37" [dir=forward tooltip="include"]
"38" -> "25" [dir=forward tooltip="include"]
"38" -> "5" [dir=forward tooltip="include"]
"38" -> "7" [dir=forward tooltip="include"]
"38" -> "8" [dir=forward tooltip="include"]
"38" -> "14" [dir=forward tooltip="include"]
"38" -> "9" [dir=forward tooltip="include"]
"38" -> "39" [dir=forward tooltip="include"]
"38" -> "17" [dir=forward tooltip="include"]
"59" -> "36" [dir=forward tooltip="include"]
"59" -> "25" [dir=forward tooltip="include"]
"59" -> "48" [dir=forward tooltip="include"]
"59" -> "10" [dir=forward tooltip="include"]
"60" -> "25" [dir=forward tooltip="include"]
"24" -> "14" [dir=forward tooltip="include"]
"24" -> "25" [dir=forward tooltip="include"]
"24" -> "5" [dir=forward tooltip="include"]
"24" -> "26" [dir=forward tooltip="include"]
"24" -> "27" [dir=forward tooltip="include"]
"55" -> "53" [dir=forward tooltip="include"]
"55" -> "25" [dir=forward tooltip="include"]
"55" -> "9" [dir=forward tooltip="include"]
"52" -> "53" [dir=forward tooltip="include"]
"52" -> "54" [dir=forward tooltip="include"]
"52" -> "44" [dir=forward tooltip="include"]
"52" -> "35" [dir=forward tooltip="include"]
"52" -> "36" [dir=forward tooltip="include"]
"52" -> "37" [dir=forward tooltip="include"]
"52" -> "25" [dir=forward tooltip="include"]
"52" -> "9" [dir=forward tooltip="include"]
"52" -> "5" [dir=forward tooltip="include"]
"52" -> "34" [dir=forward tooltip="include"]
"52" -> "7" [dir=forward tooltip="include"]
"52" -> "17" [dir=forward tooltip="include"]
"52" -> "15" [dir=forward tooltip="include"]
"52" -> "12" [dir=forward tooltip="include"]
"52" -> "51" [dir=forward tooltip="include"]
"52" -> "55" [dir=forward tooltip="include"]
"52" -> "56" [dir=forward tooltip="include"]
"52" -> "57" [dir=forward tooltip="include"]
"47" -> "43" [dir=forward tooltip="include"]
"47" -> "48" [dir=forward tooltip="include"]
"47" -> "46" [dir=forward tooltip="include"]
"47" -> "49" [dir=forward tooltip="include"]
"49" -> "35" [dir=forward tooltip="include"]
"49" -> "37" [dir=forward tooltip="include"]
"49" -> "50" [dir=forward tooltip="include"]
"41" -> "8" [dir=forward tooltip="include"]
"41" -> "14" [dir=forward tooltip="include"]
"41" -> "25" [dir=forward tooltip="include"]
"39" -> "35" [dir=forward tooltip="include"]
"39" -> "4" [dir=forward tooltip="include"]
"39" -> "6" [dir=forward tooltip="include"]
"13" -> "5" [dir=forward tooltip="include"]
"13" -> "14" [dir=forward tooltip="include"]
"13" -> "10" [dir=forward tooltip="include"]
"45" -> "46" [dir=forward tooltip="include"]
"51" -> "35" [dir=forward tooltip="include"]
"51" -> "37" [dir=forward tooltip="include"]
"51" -> "26" [dir=forward tooltip="include"]
"51" -> "9" [dir=forward tooltip="include"]
"51" -> "40" [dir=forward tooltip="include"]
"27" -> "28" [dir=forward tooltip="include"]
"27" -> "17" [dir=forward tooltip="include"]
"40" -> "17" [dir=forward tooltip="include"]
"40" -> "35" [dir=forward tooltip="include"]
"40" -> "36" [dir=forward tooltip="include"]
"40" -> "37" [dir=forward tooltip="include"]
"40" -> "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" -> "20" [dir=forward tooltip="include"]
"16" -> "21" [dir=forward tooltip="include"]
"16" -> "22" [dir=forward tooltip="include"]
"16" -> "23" [dir=forward tooltip="include"]
"16" -> "24" [dir=forward tooltip="include"]
"16" -> "29" [dir=forward tooltip="include"]
"16" -> "42" [dir=forward tooltip="include"]
"16" -> "51" [dir=forward tooltip="include"]
"16" -> "40" [dir=forward tooltip="include"]
"16" -> "52" [dir=forward tooltip="include"]
"16" -> "58" [dir=forward tooltip="include"]
"16" -> "59" [dir=forward tooltip="include"]
"16" -> "3" [dir=forward tooltip="include"]
"16" -> "60" [dir=forward tooltip="include"]
"16" -> "39" [dir=forward tooltip="include"]
"16" -> "15" [dir=forward tooltip="include"]
"2" -> "3" [dir=forward tooltip="include"]
"2" -> "16" [dir=forward tooltip="include"]
"42" -> "25" [dir=forward tooltip="include"]
"42" -> "14" [dir=forward tooltip="include"]
"42" -> "43" [dir=forward tooltip="include"]
"42" -> "44" [dir=forward tooltip="include"]
"42" -> "45" [dir=forward tooltip="include"]
"42" -> "11" [dir=forward tooltip="include"]
"42" -> "47" [dir=forward tooltip="include"]
"42" -> "15" [dir=forward tooltip="include"]
"58" -> "25" [dir=forward tooltip="include"]
"58" -> "9" [dir=forward tooltip="include"]
"58" -> "40" [dir=forward tooltip="include"]
"58" -> "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"]
"32" -> "33" [dir=forward tooltip="include"]
"32" -> "34" [dir=forward tooltip="include"]
"32" -> "35" [dir=forward tooltip="include"]
"32" -> "36" [dir=forward tooltip="include"]
"32" -> "37" [dir=forward tooltip="include"]
"29" -> "30" [dir=forward tooltip="include"]
"29" -> "17" [dir=forward tooltip="include"]
"29" -> "25" [dir=forward tooltip="include"]
"29" -> "5" [dir=forward tooltip="include"]
"29" -> "9" [dir=forward tooltip="include"]
"29" -> "28" [dir=forward tooltip="include"]
"29" -> "7" [dir=forward tooltip="include"]
"29" -> "31" [dir=forward tooltip="include"]
"29" -> "32" [dir=forward tooltip="include"]
"29" -> "38" [dir=forward tooltip="include"]
"29" -> "10" [dir=forward tooltip="include"]
"29" -> "40" [dir=forward tooltip="include"]
"29" -> "27" [dir=forward tooltip="include"]
"29" -> "41" [dir=forward tooltip="include"]
"1" -> "2" [dir=forward tooltip="include"]
}](_images/graphviz-65836a4d37f7072f20e9a16c77d19b414f3a7d70.png)
- file version.h
Variables
-
static char version_id[] = "[$Id$]"
-
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"]
}](_images/graphviz-260b5c2bce0162ec865a50c23e153e977c3ed7b7.png)
- 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"]
}](_images/graphviz-a63a0854fd97dfde6888504438ec4d6cd7c70a93.png)
- 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"]
}](_images/graphviz-6611e4d4d1748bf782354243fc6af5199313379d.png)
- 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"]
}](_images/graphviz-e73ab976018e916dc1721e16554bbc3450777e09.png)
- 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"]
}](_images/graphviz-29e4e8a4220b3415131e520b295017a3f7cc0db8.png)
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"]
}](_images/graphviz-17e4004957332a557b4099b2e672863d86626683.png)
- 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"]
}](_images/graphviz-bda351b7e1e3c2e7c68f55c0668b814776a4bf33.png)
- 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"]
}](_images/graphviz-45fd93e4a8dcd7b69355314f3cfc5cbba80a6d2b.png)
- 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"]
}](_images/graphviz-83b6dd7d9a86fa7e5ef1d4e9451e5144d5056366.png)
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"]
}](_images/graphviz-3bb0638f583057a85a9c2754bd70d7c2e8f83912.png)
- 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"]
}](_images/graphviz-65f4c29476240228d904869f8972b37f7e9f59b8.png)
- 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"]
}](_images/graphviz-ab34abc1b21762cc291f7a60427359314611a8cb.png)
Functions
-
double dplgndr(int l, int m, double x)
-
double plgndr(int l, int m, double x)
-
double dplgndr(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"]
}](_images/graphviz-543dfb38d6d572fe07b970003ee689ce10c62edf.png)
- 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"]
}](_images/graphviz-47252891e163ff79cd7a7b13d6054e5e43ab89ce.png)
- 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"]
}](_images/graphviz-9c1672f5d6bdc6df15e02c356673ac593befe943.png)
- 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"]
}](_images/graphviz-3c2c8c6fe9f3404fe6d5e10d29d0d1a2af241dcf.png)
- 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"]
}](_images/graphviz-51b13a25fb33979c1a9f5e7a0ba9f74a2ccff06a.png)
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"]
}](_images/graphviz-092c8b06abd0763e74307cc359f12cc34d8af758.png)
- 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"]
}](_images/graphviz-e477a01fd4ffdd00543b594b3cade4e11aeae06b.png)
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"]
}](_images/graphviz-156f99c5206b6d296d98ec657155d0ea183e462f.png)
Typedefs
-
typedef std::shared_ptr<SphericalSL> SphericalSLptr
-
typedef std::shared_ptr<SphericalSL> SphericalSLptr
- file atomic_constants.H
Variables
-
const double a0 = 0.052917721092e-7
-
const double amu = 1.660539e-24
-
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
-
const double a0 = 0.052917721092e-7
- 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"]
}](_images/graphviz-bb674eb49b9c64161b1fba60446710682f0b937e.png)
- 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"]
}](_images/graphviz-3fdda1f4d7b5349de36084f78872342b7428c37d.png)
- 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"]
}](_images/graphviz-d399f1fd3dd7ae6509cfdec07d7de92825ee8dde.png)
- 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"]
}](_images/graphviz-483ea113c61b56c367151da2b2e02a5beb87ecff.png)
- 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"]
}](_images/graphviz-a4150a457db309e8ee394a1979c11baa3179a375.png)
- dir /home/runner/work/EXP-docs/EXP-docs/exp_repo/utils/Analysis
- dir /home/runner/work/EXP-docs/EXP-docs/exp_repo/expui
- dir /home/runner/work/EXP-docs/EXP-docs/exp_repo/exputil
- 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
![digraph {
graph [bgcolor="#00000000"]
node [shape=rectangle style=filled fillcolor="#FFFFFF" font=Helvetica padding=2]
edge [color="#1414CE"]
"10" [label="CoefClasses::Coefs" tooltip="CoefClasses::Coefs"]
"9" [label="CoefClasses::CubeCoefs" tooltip="CoefClasses::CubeCoefs"]
"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"]
"9" -> "10" [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"]
"2" -> "9" [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"]
"4" -> "3" [dir=forward tooltip="usage"]
}](_images/graphviz-2a121e3c9feda1b699cfcd6726a6a26d99d1346d.png)
![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"]
}](_images/graphviz-2c8e622dff003b9fcfb076b3e91fbd1192eb5d06.png)
![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"]
}](_images/graphviz-44b2f6d3a4fa18ab8827451fcf55975260f97999.png)
![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"]
}](_images/graphviz-cff3314349b78a19f3feb966ec3cc0986542df2d.png)
![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"]
}](_images/graphviz-fd38a3f211b2ef780ff825934a807a4e5057996b.png)