2025-06-26 15:13:46 -04:00
# pragma once
# include "fourdst/composition/atomicSpecies.h"
# include "fourdst/composition/composition.h"
# include "fourdst/logging/logging.h"
# include "fourdst/config/config.h"
# include "gridfire/network.h"
# include "gridfire/reaction/reaction.h"
# include "gridfire/engine/engine_abstract.h"
2025-07-01 11:40:03 -04:00
# include "gridfire/screening/screening_abstract.h"
# include "gridfire/screening/screening_types.h"
2025-07-03 09:55:10 -04:00
# include "gridfire/partition/partition_abstract.h"
2025-07-14 14:50:49 -04:00
# include "gridfire/engine/procedures/construction.h"
2025-06-26 15:13:46 -04:00
# include <string>
# include <unordered_map>
# include <vector>
2025-07-01 11:40:03 -04:00
# include <memory>
2025-07-10 09:36:05 -04:00
# include <ranges>
2025-06-26 15:13:46 -04:00
# include <boost/numeric/ublas/matrix_sparse.hpp>
# include "cppad/cppad.hpp"
2025-07-14 14:50:49 -04:00
# include "cppad/utility/sparse_rc.hpp"
# include "cppad/speed/sparse_jac_fun.hpp"
# include "procedures/priming.h"
2025-07-10 09:36:05 -04:00
# include "quill/LogMacros.h"
2025-06-26 15:13:46 -04:00
// PERF: The function getNetReactionStoichiometry returns a map of species to their stoichiometric coefficients for a given reaction.
// this makes extra copies of the species, which is not ideal and could be optimized further.
// Even more relevant is the member m_reactionIDMap which makes copies of a REACLIBReaction for each reaction ID.
// REACLIBReactions are quite large data structures, so this could be a performance bottleneck.
2025-07-18 15:23:43 -04:00
// static bool isF17 = false;
2025-06-26 15:13:46 -04:00
namespace gridfire {
2025-07-14 14:50:49 -04:00
static bool s_debug = false ; // Global debug flag for the GraphEngine
2025-06-29 14:53:39 -04:00
/**
* @ brief Alias for CppAD AD type for double precision .
*
* This alias simplifies the use of the CppAD automatic differentiation type .
*/
typedef CppAD : : AD < double > ADDouble ;
2025-06-26 15:13:46 -04:00
using fourdst : : config : : Config ;
using fourdst : : logging : : LogManager ;
using fourdst : : constant : : Constants ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Minimum density threshold below which reactions are ignored .
*
* Reactions are not calculated if the density falls below this threshold .
* This helps to improve performance by avoiding unnecessary calculations
* in very low - density regimes .
*/
2025-06-26 15:13:46 -04:00
static constexpr double MIN_DENSITY_THRESHOLD = 1e-18 ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Minimum abundance threshold below which species are ignored .
*
* Species with abundances below this threshold are treated as zero in
* reaction rate calculations . This helps to improve performance by
* avoiding unnecessary calculations for trace species .
*/
2025-06-26 15:13:46 -04:00
static constexpr double MIN_ABUNDANCE_THRESHOLD = 1e-18 ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Minimum value for Jacobian matrix entries .
*
* Jacobian matrix entries with absolute values below this threshold are
* treated as zero to maintain sparsity and improve performance .
*/
2025-06-26 15:13:46 -04:00
static constexpr double MIN_JACOBIAN_THRESHOLD = 1e-24 ;
2025-07-01 14:30:45 -04:00
2025-06-29 14:53:39 -04:00
/**
* @ class GraphEngine
* @ brief A reaction network engine that uses a graph - based representation .
*
* The GraphEngine class implements the DynamicEngine interface using a
* graph - based representation of the reaction network . It uses sparse
* matrices for efficient storage and computation of the stoichiometry
* and Jacobian matrices . Automatic differentiation ( AD ) is used to
* calculate the Jacobian matrix .
*
* The engine supports :
* - Calculation of the right - hand side ( dY / dt ) and energy generation rate .
* - Generation and access to the Jacobian matrix .
* - Generation and access to the stoichiometry matrix .
* - Calculation of molar reaction flows .
* - Access to the set of logical reactions in the network .
* - Computation of timescales for each species .
* - Exporting the network to DOT and CSV formats for visualization and analysis .
*
* @ implements DynamicEngine
*
* @ see engine_abstract . h
*/
2025-06-26 15:13:46 -04:00
class GraphEngine final : public DynamicEngine {
public :
2025-06-29 14:53:39 -04:00
/**
* @ brief Constructs a GraphEngine from a composition .
*
* @ param composition The composition of the material .
*
* This constructor builds the reaction network from the given composition
* using the ` build_reaclib_nuclear_network ` function .
*
* @ see build_reaclib_nuclear_network
*/
2025-07-14 14:50:49 -04:00
explicit GraphEngine (
const fourdst : : composition : : Composition & composition ,
const BuildDepthType = NetworkBuildDepth : : Full
) ;
2025-06-26 15:13:46 -04:00
2025-07-14 14:50:49 -04:00
explicit GraphEngine (
const fourdst : : composition : : Composition & composition ,
const partition : : PartitionFunction & partitionFunction ,
const BuildDepthType buildDepth = NetworkBuildDepth : : Full
) ;
2025-07-03 09:55:10 -04:00
2025-06-29 14:53:39 -04:00
/**
* @ brief Constructs a GraphEngine from a set of reactions .
*
* @ param reactions The set of reactions to use in the network .
*
* This constructor uses the given set of reactions to construct the
* reaction network .
*/
2025-07-01 14:30:45 -04:00
explicit GraphEngine ( const reaction : : LogicalReactionSet & reactions ) ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Calculates the right - hand side ( dY / dt ) and energy generation rate .
*
* @ param Y Vector of current abundances for all species .
* @ param T9 Temperature in units of 10 ^ 9 K .
* @ param rho Density in g / cm ^ 3.
* @ return StepDerivatives < double > containing dY / dt and energy generation rate .
*
* This method calculates the time derivatives of all species and the
* specific nuclear energy generation rate for the current state .
*
* @ see StepDerivatives
*/
2025-07-22 12:48:24 -04:00
[ [ nodiscard ] ] std : : expected < StepDerivatives < double > , expectations : : StaleEngineError > calculateRHSAndEnergy (
2025-06-26 15:13:46 -04:00
const std : : vector < double > & Y ,
const double T9 ,
const double rho
) const override ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Generates the Jacobian matrix for the current state .
*
2025-07-10 09:36:05 -04:00
* @ param Y_dynamic Vector of current abundances .
2025-06-29 14:53:39 -04:00
* @ param T9 Temperature in units of 10 ^ 9 K .
* @ param rho Density in g / cm ^ 3.
*
* This method computes and stores the Jacobian matrix ( ∂ ( dY / dt ) _i / ∂ Y_j )
* for the current state using automatic differentiation . The matrix can
* then be accessed via ` getJacobianMatrixEntry ( ) ` .
*
* @ see getJacobianMatrixEntry ( )
*/
2025-06-26 15:13:46 -04:00
void generateJacobianMatrix (
2025-07-10 09:36:05 -04:00
const std : : vector < double > & Y_dynamic ,
2025-06-26 15:13:46 -04:00
const double T9 ,
const double rho
2025-07-18 15:23:43 -04:00
) const override ;
2025-06-26 15:13:46 -04:00
2025-07-14 14:50:49 -04:00
void generateJacobianMatrix (
const std : : vector < double > & Y_dynamic ,
double T9 ,
double rho ,
const SparsityPattern & sparsityPattern
2025-07-18 15:23:43 -04:00
) const override ;
2025-07-14 14:50:49 -04:00
2025-06-29 14:53:39 -04:00
/**
* @ brief Generates the stoichiometry matrix for the network .
*
* This method computes and stores the stoichiometry matrix ,
* which encodes the net change of each species in each reaction .
*/
2025-06-26 15:13:46 -04:00
void generateStoichiometryMatrix ( ) override ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Calculates the molar reaction flow for a given reaction .
*
* @ param reaction The reaction for which to calculate the flow .
* @ param Y Vector of current abundances .
* @ param T9 Temperature in units of 10 ^ 9 K .
* @ param rho Density in g / cm ^ 3.
* @ return Molar flow rate for the reaction ( e . g . , mol / g / s ) .
*
* This method computes the net rate at which the given reaction proceeds
* under the current state .
*/
2025-07-01 11:40:03 -04:00
[ [ nodiscard ] ] double calculateMolarReactionFlow (
2025-06-26 15:13:46 -04:00
const reaction : : Reaction & reaction ,
const std : : vector < double > & Y ,
const double T9 ,
const double rho
) const override ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Gets the list of species in the network .
* @ return Vector of Species objects representing all network species .
*/
2025-06-26 15:13:46 -04:00
[ [ nodiscard ] ] const std : : vector < fourdst : : atomic : : Species > & getNetworkSpecies ( ) const override ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Gets the set of logical reactions in the network .
* @ return Reference to the LogicalReactionSet containing all reactions .
*/
[ [ nodiscard ] ] const reaction : : LogicalReactionSet & getNetworkReactions ( ) const override ;
2025-07-22 12:48:24 -04:00
void setNetworkReactions ( const reaction : : LogicalReactionSet & reactions ) override ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Gets an entry from the previously generated Jacobian matrix .
*
* @ param i Row index ( species index ) .
* @ param j Column index ( species index ) .
* @ return Value of the Jacobian matrix at ( i , j ) .
*
* The Jacobian must have been generated by ` generateJacobianMatrix ( ) ` before calling this .
*
* @ see generateJacobianMatrix ( )
*/
2025-06-26 15:13:46 -04:00
[ [ nodiscard ] ] double getJacobianMatrixEntry (
const int i ,
const int j
) const override ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Gets the net stoichiometry for a given reaction .
*
* @ param reaction The reaction for which to get the stoichiometry .
* @ return Map of species to their stoichiometric coefficients .
*/
[ [ nodiscard ] ] static std : : unordered_map < fourdst : : atomic : : Species , int > getNetReactionStoichiometry (
2025-06-26 15:13:46 -04:00
const reaction : : Reaction & reaction
2025-06-29 14:53:39 -04:00
) ;
/**
* @ brief Gets an entry from the stoichiometry matrix .
*
* @ param speciesIndex Index of the species .
* @ param reactionIndex Index of the reaction .
* @ return Stoichiometric coefficient for the species in the reaction .
*
* The stoichiometry matrix must have been generated by ` generateStoichiometryMatrix ( ) ` .
*
* @ see generateStoichiometryMatrix ( )
*/
2025-06-26 15:13:46 -04:00
[ [ nodiscard ] ] int getStoichiometryMatrixEntry (
const int speciesIndex ,
const int reactionIndex
) const override ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Computes timescales for all species in the network .
*
* @ param Y Vector of current abundances .
* @ param T9 Temperature in units of 10 ^ 9 K .
* @ param rho Density in g / cm ^ 3.
* @ return Map from Species to their characteristic timescales ( s ) .
*
* This method estimates the timescale for abundance change of each species ,
* which can be used for timestep control or diagnostics .
*/
2025-07-22 12:48:24 -04:00
[ [ nodiscard ] ] std : : expected < std : : unordered_map < fourdst : : atomic : : Species , double > , expectations : : StaleEngineError > getSpeciesTimescales (
const std : : vector < double > & Y ,
double T9 ,
double rho
) const override ;
[ [ nodiscard ] ] std : : expected < std : : unordered_map < fourdst : : atomic : : Species , double > , expectations : : StaleEngineError > getSpeciesDestructionTimescales (
2025-06-26 15:13:46 -04:00
const std : : vector < double > & Y ,
double T9 ,
double rho
) const override ;
2025-07-18 15:23:43 -04:00
fourdst : : composition : : Composition update ( const NetIn & netIn ) override ;
bool isStale ( const NetIn & netIn ) override ;
2025-07-01 11:40:03 -04:00
2025-06-29 14:53:39 -04:00
/**
* @ brief Checks if a given species is involved in the network .
*
* @ param species The species to check .
* @ return True if the species is involved in the network , false otherwise .
*/
2025-06-26 15:13:46 -04:00
[ [ nodiscard ] ] bool involvesSpecies (
const fourdst : : atomic : : Species & species
) const ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Exports the network to a DOT file for visualization .
*
* @ param filename The name of the DOT file to create .
*
* This method generates a DOT file that can be used to visualize the
* reaction network as a graph . The DOT file can be converted to a
* graphical image using Graphviz .
*
* @ throws std : : runtime_error If the file cannot be opened for writing .
*
* Example usage :
* @ code
* engine . exportToDot ( " network.dot " ) ;
* @ endcode
*/
2025-06-26 15:13:46 -04:00
void exportToDot (
const std : : string & filename
) const ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Exports the network to a CSV file for analysis .
*
* @ param filename The name of the CSV file to create .
*
* This method generates a CSV file containing information about the
* reactions in the network , including the reactants , products , Q - value ,
* and reaction rate coefficients .
*
* @ throws std : : runtime_error If the file cannot be opened for writing .
*
* Example usage :
* @ code
* engine . exportToCSV ( " network.csv " ) ;
* @ endcode
*/
2025-06-26 15:13:46 -04:00
void exportToCSV (
const std : : string & filename
) const ;
2025-07-01 11:40:03 -04:00
void setScreeningModel ( screening : : ScreeningType ) override ;
[ [ nodiscard ] ] screening : : ScreeningType getScreeningModel ( ) const override ;
2025-07-01 14:30:45 -04:00
void setPrecomputation ( bool precompute ) ;
[ [ nodiscard ] ] bool isPrecomputationEnabled ( ) const ;
2025-07-03 09:55:10 -04:00
[ [ nodiscard ] ] const partition : : PartitionFunction & getPartitionFunction ( ) const ;
[ [ nodiscard ] ] double calculateReverseRate (
const reaction : : Reaction & reaction ,
2025-07-10 09:36:05 -04:00
double T9
) const ;
2025-07-14 14:50:49 -04:00
[ [ nodiscard ] ] double calculateReverseRateTwoBody (
2025-07-10 09:36:05 -04:00
const reaction : : Reaction & reaction ,
const double T9 ,
const double forwardRate ,
const double expFactor
2025-07-03 09:55:10 -04:00
) const ;
2025-07-14 14:50:49 -04:00
[ [ nodiscard ] ] double calculateReverseRateTwoBodyDerivative (
2025-07-10 09:36:05 -04:00
const reaction : : Reaction & reaction ,
const double T9 ,
const double reverseRate
) const ;
2025-07-14 14:50:49 -04:00
[ [ nodiscard ] ] bool isUsingReverseReactions ( ) const ;
2025-07-10 09:36:05 -04:00
void setUseReverseReactions ( bool useReverse ) ;
2025-07-14 14:50:49 -04:00
[ [ nodiscard ] ] int getSpeciesIndex (
2025-07-10 09:36:05 -04:00
const fourdst : : atomic : : Species & species
) const override ;
2025-07-14 14:50:49 -04:00
[ [ nodiscard ] ] std : : vector < double > mapNetInToMolarAbundanceVector ( const NetIn & netIn ) const override ;
[ [ nodiscard ] ] PrimingReport primeEngine ( const NetIn & netIn ) override ;
[ [ nodiscard ] ] BuildDepthType getDepth ( ) const override ;
void rebuild ( const fourdst : : composition : : Composition & comp , const BuildDepthType depth ) override ;
2025-07-10 09:36:05 -04:00
2025-07-01 14:30:45 -04:00
private :
struct PrecomputedReaction {
2025-07-10 09:36:05 -04:00
// Forward cacheing
2025-07-01 14:30:45 -04:00
size_t reaction_index ;
std : : vector < size_t > unique_reactant_indices ;
std : : vector < int > reactant_powers ;
double symmetry_factor ;
std : : vector < size_t > affected_species_indices ;
std : : vector < int > stoichiometric_coefficients ;
2025-07-10 09:36:05 -04:00
// Reverse cacheing
std : : vector < size_t > unique_product_indices ; ///< Unique product indices for reverse reactions.
std : : vector < int > product_powers ; ///< Powers of each unique product in the reverse reaction.
double reverse_symmetry_factor ; ///< Symmetry factor for reverse reactions.
2025-07-01 14:30:45 -04:00
} ;
struct constants {
const double u = Constants : : getInstance ( ) . get ( " u " ) . value ; ///< Atomic mass unit in g.
const double Na = Constants : : getInstance ( ) . get ( " N_a " ) . value ; ///< Avogadro's number.
const double c = Constants : : getInstance ( ) . get ( " c " ) . value ; ///< Speed of light in cm/s.
2025-07-03 09:55:10 -04:00
const double kB = Constants : : getInstance ( ) . get ( " kB " ) . value ; ///< Boltzmann constant in erg/K.
2025-07-01 14:30:45 -04:00
} ;
2025-07-10 09:36:05 -04:00
private :
class AtomicReverseRate final : public CppAD : : atomic_base < double > {
public :
AtomicReverseRate (
const reaction : : Reaction & reaction ,
const GraphEngine & engine
) :
atomic_base < double > ( " AtomicReverseRate " ) ,
m_reaction ( reaction ) ,
m_engine ( engine ) { }
bool forward (
size_t p ,
size_t q ,
const CppAD : : vector < bool > & vx ,
CppAD : : vector < bool > & vy ,
const CppAD : : vector < double > & tx ,
CppAD : : vector < double > & ty
) override ;
bool reverse (
size_t q ,
const CppAD : : vector < double > & tx ,
const CppAD : : vector < double > & ty ,
CppAD : : vector < double > & px ,
const CppAD : : vector < double > & py
) override ;
bool for_sparse_jac (
size_t q ,
const CppAD : : vector < std : : set < size_t > > & r ,
CppAD : : vector < std : : set < size_t > > & s
) override ;
bool rev_sparse_jac (
size_t q ,
const CppAD : : vector < std : : set < size_t > > & rt ,
CppAD : : vector < std : : set < size_t > > & st
) override ;
private :
const reaction : : Reaction & m_reaction ;
const GraphEngine & m_engine ;
} ;
2025-06-26 15:13:46 -04:00
private :
2025-07-01 14:30:45 -04:00
Config & m_config = Config : : getInstance ( ) ;
quill : : Logger * m_logger = LogManager : : getInstance ( ) . getLogger ( " log " ) ;
constants m_constants ;
2025-06-29 14:53:39 -04:00
reaction : : LogicalReactionSet m_reactions ; ///< Set of REACLIB reactions in the network.
2025-06-26 15:13:46 -04:00
std : : unordered_map < std : : string_view , reaction : : Reaction * > m_reactionIDMap ; ///< Map from reaction ID to REACLIBReaction. //PERF: This makes copies of REACLIBReaction and could be a performance bottleneck.
std : : vector < fourdst : : atomic : : Species > m_networkSpecies ; ///< Vector of unique species in the network.
std : : unordered_map < std : : string_view , fourdst : : atomic : : Species > m_networkSpeciesMap ; ///< Map from species name to Species object.
std : : unordered_map < fourdst : : atomic : : Species , size_t > m_speciesToIndexMap ; ///< Map from species to their index in the stoichiometry matrix.
boost : : numeric : : ublas : : compressed_matrix < int > m_stoichiometryMatrix ; ///< Stoichiometry matrix (species x reactions).
2025-07-18 15:23:43 -04:00
mutable boost : : numeric : : ublas : : compressed_matrix < double > m_jacobianMatrix ; ///< Jacobian matrix (species x species).
mutable CppAD : : ADFun < double > m_rhsADFun ; ///< CppAD function for the right-hand side of the ODE.
mutable CppAD : : sparse_jac_work m_jac_work ; ///< Work object for sparse Jacobian calculations.
2025-07-14 14:50:49 -04:00
CppAD : : sparse_rc < std : : vector < size_t > > m_full_jacobian_sparsity_pattern ; ///< Full sparsity pattern for the Jacobian matrix.
2025-07-18 15:23:43 -04:00
2025-07-10 09:36:05 -04:00
std : : vector < std : : unique_ptr < AtomicReverseRate > > m_atomicReverseRates ;
2025-06-26 15:13:46 -04:00
2025-07-01 11:40:03 -04:00
screening : : ScreeningType m_screeningType = screening : : ScreeningType : : BARE ; ///< Screening type for the reaction network. Default to no screening.
std : : unique_ptr < screening : : ScreeningModel > m_screeningModel = screening : : selectScreeningModel ( m_screeningType ) ;
2025-07-01 14:30:45 -04:00
bool m_usePrecomputation = true ; ///< Flag to enable or disable using precomputed reactions for efficiency. Mathematically, this should not change the results. Generally end users should not need to change this.
2025-07-10 09:36:05 -04:00
bool m_useReverseReactions = true ; ///< Flag to enable or disable reverse reactions. If false, only forward reactions are considered.
2025-07-14 14:50:49 -04:00
BuildDepthType m_depth ;
2025-07-01 14:30:45 -04:00
std : : vector < PrecomputedReaction > m_precomputedReactions ; ///< Precomputed reactions for efficiency.
2025-07-03 09:55:10 -04:00
std : : unique_ptr < partition : : PartitionFunction > m_partitionFunction ; ///< Partition function for the network.
2025-06-26 15:13:46 -04:00
private :
2025-06-29 14:53:39 -04:00
/**
* @ brief Synchronizes the internal maps .
*
* This method synchronizes the internal maps used by the engine ,
* including the species map , reaction ID map , and species - to - index map .
* It also generates the stoichiometry matrix and records the AD tape .
*/
2025-06-26 15:13:46 -04:00
void syncInternalMaps ( ) ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Collects the unique species in the network .
*
* This method collects the unique species in the network from the
* reactants and products of all reactions .
*/
2025-06-26 15:13:46 -04:00
void collectNetworkSpecies ( ) ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Populates the reaction ID map .
*
* This method populates the reaction ID map , which maps reaction IDs
* to REACLIBReaction objects .
*/
2025-06-26 15:13:46 -04:00
void populateReactionIDMap ( ) ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Populates the species - to - index map .
*
* This method populates the species - to - index map , which maps species
* to their index in the stoichiometry matrix .
*/
2025-06-26 15:13:46 -04:00
void populateSpeciesToIndexMap ( ) ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Reserves space for the Jacobian matrix .
*
* This method reserves space for the Jacobian matrix , which is used
* to store the partial derivatives of the right - hand side of the ODE
* with respect to the species abundances .
*/
2025-07-22 12:48:24 -04:00
void reserveJacobianMatrix ( ) const ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Records the AD tape for the right - hand side of the ODE .
*
* This method records the AD tape for the right - hand side of the ODE ,
* which is used to calculate the Jacobian matrix using automatic
* differentiation .
*
* @ throws std : : runtime_error If there are no species in the network .
*/
2025-06-26 15:13:46 -04:00
void recordADTape ( ) ;
2025-07-10 09:36:05 -04:00
void collectAtomicReverseRateAtomicBases ( ) ;
2025-07-01 14:30:45 -04:00
void precomputeNetwork ( ) ;
2025-07-10 09:36:05 -04:00
2025-06-29 14:53:39 -04:00
/**
* @ brief Validates mass and charge conservation across all reactions .
*
* @ return True if all reactions conserve mass and charge , false otherwise .
*
* This method checks that all reactions in the network conserve mass
* and charge . If any reaction does not conserve mass or charge , an
* error message is logged and false is returned .
*/
2025-06-26 15:13:46 -04:00
[ [ nodiscard ] ] bool validateConservation ( ) const ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Validates the composition against the current reaction set .
*
* @ param composition The composition to validate .
* @ param culling The culling threshold to use .
* @ param T9 The temperature to use .
*
* This method validates the composition against the current reaction set .
* If the composition is not compatible with the reaction set , the
* reaction set is rebuilt from the composition .
*/
2025-06-26 15:13:46 -04:00
void validateComposition (
const fourdst : : composition : : Composition & composition ,
double culling ,
double T9
) ;
2025-07-03 09:55:10 -04:00
2025-07-01 14:30:45 -04:00
[ [ nodiscard ] ] StepDerivatives < double > calculateAllDerivativesUsingPrecomputation (
const std : : vector < double > & Y_in ,
const std : : vector < double > & bare_rates ,
2025-07-10 09:36:05 -04:00
const std : : vector < double > & bare_reverse_rates ,
double T9 , double rho
2025-07-01 14:30:45 -04:00
) const ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Calculates the molar reaction flow for a given reaction .
*
* @ tparam T The numeric type to use for the calculation .
* @ param reaction The reaction for which to calculate the flow .
* @ param Y Vector of current abundances .
* @ param T9 Temperature in units of 10 ^ 9 K .
* @ param rho Density in g / cm ^ 3.
* @ return Molar flow rate for the reaction ( e . g . , mol / g / s ) .
*
* This method computes the net rate at which the given reaction proceeds
* under the current state .
*/
2025-06-26 15:13:46 -04:00
template < IsArithmeticOrAD T >
T calculateMolarReactionFlow (
const reaction : : Reaction & reaction ,
const std : : vector < T > & Y ,
const T T9 ,
const T rho
) const ;
2025-07-10 09:36:05 -04:00
template < IsArithmeticOrAD T >
T calculateReverseMolarReactionFlow (
T T9 ,
T rho ,
std : : vector < T > screeningFactors ,
std : : vector < T > Y ,
size_t reactionIndex ,
const reaction : : LogicalReaction & reaction
) const ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Calculates all derivatives ( dY / dt ) and the energy generation rate .
*
* @ tparam T The numeric type to use for the calculation .
* @ param Y_in Vector of current abundances for all species .
* @ param T9 Temperature in units of 10 ^ 9 K .
* @ param rho Density in g / cm ^ 3.
* @ return StepDerivatives < T > containing dY / dt and energy generation rate .
*
* This method calculates the time derivatives of all species and the
* specific nuclear energy generation rate for the current state .
*/
2025-06-26 15:13:46 -04:00
template < IsArithmeticOrAD T >
2025-07-01 11:40:03 -04:00
[ [ nodiscard ] ] StepDerivatives < T > calculateAllDerivatives (
2025-06-26 15:13:46 -04:00
const std : : vector < T > & Y_in ,
T T9 ,
T rho
) const ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Calculates all derivatives ( dY / dt ) and the energy generation rate ( double precision ) .
*
* @ param Y_in Vector of current abundances for all species .
* @ param T9 Temperature in units of 10 ^ 9 K .
* @ param rho Density in g / cm ^ 3.
* @ return StepDerivatives < double > containing dY / dt and energy generation rate .
*
* This method calculates the time derivatives of all species and the
* specific nuclear energy generation rate for the current state using
* double precision arithmetic .
*/
2025-07-01 11:40:03 -04:00
[ [ nodiscard ] ] StepDerivatives < double > calculateAllDerivatives (
2025-06-26 15:13:46 -04:00
const std : : vector < double > & Y_in ,
const double T9 ,
const double rho
) const ;
2025-06-29 14:53:39 -04:00
/**
* @ brief Calculates all derivatives ( dY / dt ) and the energy generation rate ( automatic differentiation ) .
*
* @ param Y_in Vector of current abundances for all species .
* @ param T9 Temperature in units of 10 ^ 9 K .
* @ param rho Density in g / cm ^ 3.
* @ return StepDerivatives < ADDouble > containing dY / dt and energy generation rate .
*
* This method calculates the time derivatives of all species and the
* specific nuclear energy generation rate for the current state using
* automatic differentiation .
*/
2025-07-01 11:40:03 -04:00
[ [ nodiscard ] ] StepDerivatives < ADDouble > calculateAllDerivatives (
2025-06-26 15:13:46 -04:00
const std : : vector < ADDouble > & Y_in ,
2025-06-29 14:53:39 -04:00
const ADDouble & T9 ,
const ADDouble & rho
2025-06-26 15:13:46 -04:00
) const ;
} ;
2025-07-10 09:36:05 -04:00
template < IsArithmeticOrAD T >
T GraphEngine : : calculateReverseMolarReactionFlow (
T T9 ,
T rho ,
std : : vector < T > screeningFactors ,
std : : vector < T > Y ,
size_t reactionIndex ,
const reaction : : LogicalReaction & reaction
) const {
if ( ! m_useReverseReactions ) {
return static_cast < T > ( 0.0 ) ; // If reverse reactions are not used, return zero
}
2025-07-14 14:50:49 -04:00
s_debug = false ;
if ( reaction . peName ( ) = = " p(p,e+)d " | | reaction . peName ( ) = = " d(d,n)he3 " | | reaction . peName ( ) = = " c12(p,g)n13 " ) {
if constexpr ( ! std : : is_same_v < T , ADDouble > ) {
s_debug = true ;
std : : cout < < " Calculating reverse molar flow for reaction: " < < reaction . peName ( ) < < std : : endl ;
std : : cout < < " \t T9: " < < T9 < < " , rho: " < < rho < < std : : endl ;
}
}
2025-07-10 09:36:05 -04:00
T reverseMolarFlow = static_cast < T > ( 0.0 ) ;
if ( reaction . qValue ( ) ! = 0.0 ) {
T reverseRateConstant = static_cast < T > ( 0.0 ) ;
if constexpr ( std : : is_same_v < T , ADDouble > ) { // Check if T is an AD type at compile time
const auto & atomic_func_ptr = m_atomicReverseRates [ reactionIndex ] ;
if ( atomic_func_ptr ! = nullptr ) {
// A. Instantiate the atomic operator for the specific reaction
// B. Marshal the input vector
std : : vector < T > ax = { T9 } ;
std : : vector < T > ay ( 1 ) ;
( * atomic_func_ptr ) ( ax , ay ) ;
reverseRateConstant = static_cast < T > ( ay [ 0 ] ) ;
} else {
return reverseMolarFlow ; // If no atomic function is available, return zero
}
} else {
// A,B If not calling with an AD type, calculate the reverse rate directly
2025-07-14 14:50:49 -04:00
if ( s_debug ) {
std : : cout < < " \t Using double overload \n " ;
}
2025-07-10 09:36:05 -04:00
reverseRateConstant = calculateReverseRate ( reaction , T9 ) ;
}
// C. Get product multiplicities
std : : unordered_map < fourdst : : atomic : : Species , int > productCounts ;
for ( const auto & product : reaction . products ( ) ) {
productCounts [ product ] + + ;
}
// D. Calculate the symmetry factor
T reverseSymmetryFactor = static_cast < T > ( 1.0 ) ;
for ( const auto & count : productCounts | std : : views : : values ) {
reverseSymmetryFactor / = static_cast < T > ( std : : tgamma ( static_cast < double > ( count + 1 ) ) ) ; // Gamma function for factorial
}
// E. Calculate the abundance term
T productAbundanceTerm = static_cast < T > ( 1.0 ) ;
for ( const auto & [ species , count ] : productCounts ) {
2025-07-14 14:50:49 -04:00
const unsigned long speciesIndex = m_speciesToIndexMap . at ( species ) ;
2025-07-10 09:36:05 -04:00
productAbundanceTerm * = CppAD : : pow ( Y [ speciesIndex ] , count ) ;
}
// F. Determine the power for the density term
const size_t num_products = reaction . products ( ) . size ( ) ;
const T rho_power = CppAD : : pow ( rho , static_cast < T > ( num_products > 1 ? num_products - 1 : 0 ) ) ; // Density raised to the power of (N-1) for N products
// G. Assemble the reverse molar flow rate
reverseMolarFlow = screeningFactors [ reactionIndex ] *
reverseRateConstant *
productAbundanceTerm *
reverseSymmetryFactor *
rho_power ;
}
return reverseMolarFlow ;
}
2025-06-26 15:13:46 -04:00
template < IsArithmeticOrAD T >
StepDerivatives < T > GraphEngine : : calculateAllDerivatives (
const std : : vector < T > & Y_in , T T9 , T rho ) const {
2025-07-01 11:40:03 -04:00
std : : vector < T > screeningFactors = m_screeningModel - > calculateScreeningFactors (
m_reactions ,
m_networkSpecies ,
Y_in ,
T9 ,
rho
) ;
2025-06-26 15:13:46 -04:00
// --- Setup output derivatives structure ---
StepDerivatives < T > result ;
result . dydt . resize ( m_networkSpecies . size ( ) , static_cast < T > ( 0.0 ) ) ;
// --- AD Pre-setup (flags to control conditionals in an AD safe / branch aware manner) ---
// ----- Constants for AD safe calculations ---
const T zero = static_cast < T > ( 0.0 ) ;
const T one = static_cast < T > ( 1.0 ) ;
// ----- Initialize variables for molar concentration product and thresholds ---
// Note: the logic here is that we use CppAD::CondExprLt to test thresholds and if they are less we set the flag
// to zero so that the final returned reaction flow is 0. This is as opposed to standard if statements
// which create branches that break the AD tape.
const T rho_threshold = static_cast < T > ( MIN_DENSITY_THRESHOLD ) ;
// --- Check if the density is below the threshold where we ignore reactions ---
T threshold_flag = CppAD : : CondExpLt ( rho , rho_threshold , zero , one ) ; // If rho < threshold, set flag to 0
std : : vector < T > Y = Y_in ;
for ( size_t i = 0 ; i < m_networkSpecies . size ( ) ; + + i ) {
// We use CppAD::CondExpLt to handle AD taping and prevent branching
// Note that while this is syntactically more complex this is equivalent to
// if (Y[i] < 0) {Y[i] = 0;}
// The issue is that this would introduce a branch which would require the auto diff tape to be re-recorded
// each timestep, which is very inefficient.
Y [ i ] = CppAD : : CondExpLt ( Y [ i ] , zero , zero , Y [ i ] ) ; // Ensure no negative abundances
}
2025-07-01 14:30:45 -04:00
const T u = static_cast < T > ( m_constants . u ) ; // Atomic mass unit in grams
const T N_A = static_cast < T > ( m_constants . Na ) ; // Avogadro's number in mol^-1
const T c = static_cast < T > ( m_constants . c ) ; // Speed of light in cm/s
2025-06-26 15:13:46 -04:00
// --- SINGLE LOOP OVER ALL REACTIONS ---
for ( size_t reactionIndex = 0 ; reactionIndex < m_reactions . size ( ) ; + + reactionIndex ) {
const auto & reaction = m_reactions [ reactionIndex ] ;
2025-07-10 09:36:05 -04:00
// 1. Calculate forward reaction rate
const T forwardMolarReactionFlow = screeningFactors [ reactionIndex ] *
calculateMolarReactionFlow < T > ( reaction , Y , T9 , rho ) ;
// 2. Calculate reverse reaction rate
T reverseMolarFlow = calculateReverseMolarReactionFlow < T > (
T9 ,
rho ,
screeningFactors ,
Y ,
reactionIndex ,
reaction
) ;
const T molarReactionFlow = forwardMolarReactionFlow - reverseMolarFlow ; // Net molar reaction flow
// 3. Use the rate to update all relevant species derivatives (dY/dt)
2025-06-26 15:13:46 -04:00
for ( size_t speciesIndex = 0 ; speciesIndex < m_networkSpecies . size ( ) ; + + speciesIndex ) {
const T nu_ij = static_cast < T > ( m_stoichiometryMatrix ( speciesIndex , reactionIndex ) ) ;
2025-07-10 09:36:05 -04:00
result . dydt [ speciesIndex ] + = threshold_flag * nu_ij * molarReactionFlow ;
2025-06-26 15:13:46 -04:00
}
}
T massProductionRate = static_cast < T > ( 0.0 ) ; // [mol][s^-1]
for ( const auto & [ species , index ] : m_speciesToIndexMap ) {
massProductionRate + = result . dydt [ index ] * species . mass ( ) * u ;
}
result . nuclearEnergyGenerationRate = - massProductionRate * N_A * c * c ; // [cm^2][s^-3] = [erg][s^-1][g^-1]
return result ;
}
template < IsArithmeticOrAD T >
T GraphEngine : : calculateMolarReactionFlow (
const reaction : : Reaction & reaction ,
const std : : vector < T > & Y ,
const T T9 ,
const T rho
) const {
// --- Pre-setup (flags to control conditionals in an AD safe / branch aware manner) ---
// ----- Constants for AD safe calculations ---
const T zero = static_cast < T > ( 0.0 ) ;
const T one = static_cast < T > ( 1.0 ) ;
// ----- Initialize variables for molar concentration product and thresholds ---
// Note: the logic here is that we use CppAD::CondExprLt to test thresholds and if they are less we set the flag
// to zero so that the final returned reaction flow is 0. This is as opposed to standard if statements
// which create branches that break the AD tape.
const T Y_threshold = static_cast < T > ( MIN_ABUNDANCE_THRESHOLD ) ;
T threshold_flag = one ;
// --- Calculate the molar reaction rate (in units of [s^-1][cm^3(N-1)][mol^(1-N)] for N reactants) ---
const T k_reaction = reaction . calculate_rate ( T9 ) ;
// --- Cound the number of each reactant species to account for species multiplicity ---
std : : unordered_map < std : : string , int > reactant_counts ;
reactant_counts . reserve ( reaction . reactants ( ) . size ( ) ) ;
for ( const auto & reactant : reaction . reactants ( ) ) {
reactant_counts [ std : : string ( reactant . name ( ) ) ] + + ;
}
2025-07-10 09:36:05 -04:00
const int totalReactants = static_cast < int > ( reaction . reactants ( ) . size ( ) ) ;
2025-06-26 15:13:46 -04:00
// --- Accumulator for the molar concentration ---
auto molar_concentration_product = static_cast < T > ( 1.0 ) ;
// --- Loop through each unique reactant species and calculate the molar concentration for that species then multiply that into the accumulator ---
for ( const auto & [ species_name , count ] : reactant_counts ) {
// --- Resolve species to molar abundance ---
// PERF: Could probably optimize out this lookup
const auto species_it = m_speciesToIndexMap . find ( m_networkSpeciesMap . at ( species_name ) ) ;
const size_t species_index = species_it - > second ;
const T Yi = Y [ species_index ] ;
// --- Check if the species abundance is below the threshold where we ignore reactions ---
2025-07-10 09:36:05 -04:00
// threshold_flag *= CppAD::CondExpLt(Yi, Y_threshold, zero, one);
2025-06-26 15:13:46 -04:00
// --- If count is > 1 , we need to raise the molar concentration to the power of count since there are really count bodies in that reaction ---
2025-07-10 09:36:05 -04:00
molar_concentration_product * = CppAD : : pow ( Yi , static_cast < T > ( count ) ) ; // ni^count
2025-06-26 15:13:46 -04:00
// --- Apply factorial correction for identical reactions ---
if ( count > 1 ) {
molar_concentration_product / = static_cast < T > ( std : : tgamma ( static_cast < double > ( count + 1 ) ) ) ; // Gamma function for factorial
}
}
2025-07-10 09:36:05 -04:00
// --- Final reaction flow calculation [mol][s^-1][g^-1] ---
2025-06-26 15:13:46 -04:00
// Note: If the threshold flag ever gets set to zero this will return zero.
// This will result basically in multiple branches being written to the AD tape, which will make
// the tape more expensive to record, but it will also mean that we only need to record it once for
// the entire network.
2025-07-10 09:36:05 -04:00
const T densityTerm = CppAD : : pow ( rho , totalReactants > 1 ? static_cast < T > ( totalReactants - 1 ) : zero ) ; // Density raised to the power of (N-1) for N reactants
return molar_concentration_product * k_reaction * threshold_flag * densityTerm ;
2025-06-26 15:13:46 -04:00
}
2025-07-03 09:55:10 -04:00
2025-06-26 15:13:46 -04:00
} ;