| NEigen | Linear algebra library. Used by Hexed but not included with the source |
| ►Nhexed | Global namespace for all of the C++ API of Hexed |
| ►Nassert | Utilities for custom assertions |
| CException | |
| CNumerical_exception | Fatal problem in the numerics of the code (such as nonphysical values) |
| CUser_error | Exception which clearly results from a mistake made by the user |
| Nconfig | Namespace for options configured at build time. See hexed_config.hpp.in |
| Nconstants | Mathematical and physical constants |
| Ncriteria | A namespace for functions to be used as refinement criteria |
| Nhil_properties | Functions that assign properties of objects to HIL variables |
| Niterative | Iterative solvers for linear equations, in particular Krylov subspace methods |
| ►Nmath | Miscellaneous mathematical functions that aren't in std::math |
| CApprox_equal | Functor to compare whether values are approximately equal |
| CBall | Minimal representation of an n_dim-dimensional ball |
| CRoot_options | Convenient way to pass options to root-finding algorithms |
| ►Nmutual | Namespace for mutually-connected objects |
| CBase | Abstract base class for all mutually-connected objects |
| CMultiple | Object that can be mutually connected with any number of partners |
| CSingle | Object which is mutually connected ("paired") with only one other object |
| ►Npde | This namespace contains classes representing the different PDEs Hexed can solve |
| ►CAdvection | |
| CComputation | |
| ►CFix_therm_admis | |
| CComputation | |
| ►CNavier_stokes | |
| ►CPde | |
| CCharacteristics | |
| CComputation | |
| ►CSmooth_art_visc | |
| CComputation | |
| ►CAccessible_mesh | A mesh that supports access to the actual elements with the numerical data they contain |
| CMasked_mesh | Creates a mask that allows kernel operations to be performed on a subset of the elements |
| CAdvection_state | Fetches the advection states used for computing the smoothness-based artfificial viscosity |
| CAnnular_diffusion_test | Steady-state solution to Laplacian diffusion in an anular domain (for verification testing) |
| CArray | Represents a dynamic-sized multidimensional array |
| CArt_visc_coef | Fetches the artificial viscosity coefficient |
| CArt_visc_forcing | Fetches one of the forcing variables in artificial viscosity computation |
| CBasis | Represents a basis of Lagrange polynomials |
| CBoundary | |
| CBoundary_condition | |
| CBoundary_connection | A Boundary_face that also provides details about the connection for the neighbor flux computation and requests for a particular Boundary_condition to be applied to it |
| CBoundary_expr | Evaluates a structured expression |
| CBoundary_face | |
| CBoundary_func | A funtion that can be evaluated at any quadrature point which is on a boundary |
| CCache_bc | |
| CCase | |
| CCommand_input | Handles command line input with history |
| CComplete_element_container | |
| CComponent | Returns a component of another Qpoint_func |
| CCompound_geom | Combines multiple Surface_geoms into one |
| CCompound_printer | Printer which is just a combination of other printers |
| CCon_dir | |
| CCon_dir< Deformed_element > | |
| CCon_dir< Element > | |
| CConcat_func | Concatenates the output of a vector of function-type objects (derived from Output_data) |
| CConcatenation | A Sequence formed by concatenating two Sequences |
| CConnection | |
| CConnection_direction | |
| CConnection_new | |
| CConstant_func | Always returns the same constant (vector) value |
| CCopy | |
| CCsv | Writes output in Comma-Separated Value format |
| CDeformed_element | Represents an Element which is not a perfect axis-aligned square/cube |
| CDense_equation | Equation in \( \mathbb{R}^n \) with a dense matrix |
| CDerivative | |
| CDiff_sq | Computes the elementwise squared difference between the output of 2 Domain_funcs |
| CDomain_func | |
| CDoublet | |
| CElem_average | Computes the average of the provided Qpoint_func within the element by Gaussian quadrature |
| CElem_l2 | Computes the \(L_2\) norm of the provided Qpoint_func within the element by Gaussian quadrature |
| CElem_nonsmooth | Compute the elementwise nonsmoothness indicator of the provided function |
| CElement | Stores data associated with one mesh element |
| CElement_connection | |
| CElement_container | |
| CElement_face_connection | |
| CElement_func | Function that has a single value for each element |
| CElement_info | Element_func that doesn't depend on a Basis or the time |
| CElement_new | |
| CEmpty_func | Returns an empty vector. You can pass this to Solver::visualize_field_tecplot if you just want to visualize the position |
| CEquiangle_skewness | Computes the equiangle skewness mesh quality metric |
| CEquidistant | Basis with equidistant quadrature points |
| CError_func | |
| ►CFace | |
| CConnect | |
| CFace_connection | |
| CFace_connection< Deformed_element > | |
| CFace_permutation_dynamic | |
| CFix_admis_coef | Fetches the Element::fix_admis_coef |
| CFlow_bc | Abstract class representing an arbitrary flow boundary condition (as opposed to a mesh BC) |
| CFreestream | Sets the ghost state to the provided freestream state |
| CFunction_bc | Like Freestream, but sets state to the value of an arbitrary Surface_func instead of a constant |
| CGauss_legendre | Basis based on Gauss-Legendre quadrature |
| CGauss_lobatto | Basis based on Gauss-Lobatto quadrature |
| CGeom_mbc | Snaps to a Surface_geom |
| CHanging | |
| CHanging_vertex_matcher | |
| CHas_tree | Returns 1 if the element has a Tree pointer, else 0 |
| CHeat_flux | Computes heat flux into surface |
| CHil_exception | |
| CHistory_monitor | Monitors the history of some variable over iterations and computes the bounds over a specified window |
| CHypersphere | Represents hypersphere in any dimensionality |
| CIndex | Provides a view of some elements of a Sequence identified by a sequence of indices |
| ►CInterpreter | |
| CHil_unhandled_exception | |
| CIs_deformed | Returns 1 if the element is deformed, otherwise 0 |
| CIteration_status | Contains high-level diagnostic information about the status of a time-marching scheme |
| CIterator | A random-access iterator type based on an arbitrary access function |
| CJac_inv_det_func | Determinant of inverse of Jacobian |
| CJacobian_det_func | Returns a vector with one element: the Jacobian determinant at the quadrature point |
| CKernel | |
| CKernel_connection | Represents a connection between elements as the kernel sees it |
| CKernel_element | Represents an element as the kernels see it |
| CKernel_mesh | |
| CKernel_options | |
| CLayer_sequence | Selects a growth profile for anisotropic wall layers |
| CLinear | Computes a single output variable which is a linear combination of components of position |
| CLinear_equation | Linear equation in an arbitrary vector space with a black-box operator |
| ►CLock | Wrapper for OpenMP lock routines |
| CAcquire | Acquires the lock when constructed and releases when destroyed |
| CMach | Computes Mach number |
| CMass | Aka density |
| ►CMesh | |
| CConnection_validity | An object to provide information about whether the mesh connectivity is valid and if not, why |
| Celem_handle | Minimum information required to identify an element |
| CReset_vertices | Temporarily resets the vertices of a mesh to their nominal positions for debugging |
| CMesh_bc | Abstract class representing a mesh boundary condition |
| ►CMesh_by_type | |
| CConnection_view | Sequence of some type of connection object which cycles through first the conformal connections and then the hanging-node connections |
| CMortal | Object that could die at any moment |
| CMortal_ptr | Pointer to a Mortal object that will be updated if the object is destroyed or moved |
| CMultiple_ptr | Like a Mutual_ptr, except it can accept multiple partners |
| CMutual_ptr | For creating pairs of mutually connected pointers in a robust way |
| ►CNamespace | |
| CHeisenberg | |
| CValue | |
| CVariable | |
| CNearest_point | Helper class for finding the nearest point to a given reference point |
| CNo_slip | No-slip wall boundary condition |
| CNominal_pos | |
| CNonpenetration | Copies the inside state and flips the sign of the surface-normal velocity |
| CNormalized_nonsmooth | Same as Elem_nonsmooth, but normalized by Elem_l2 |
| CNull_mbc | Snapping functions that do nothing |
| ►COcct | Wrapper interface for CAD geometry defined by Open CASCADE Technology (OCCT) |
| CGeom | A Surface_geom that interacts with a CAD object directly |
| COutflow | For supersonic outlets |
| COutput_data | Represents some numerical data which is of interest to the end user |
| COutward_normal | Returns the surface normal vector |
| CPath | Finds a file in the working directory or system paths |
| CPhysical_basis | |
| CPhysical_residual | Returns the residual of the Navier-Stokes equations, not weighted by local time step |
| CPointer | Abstract base class for implementing pointer objects |
| CPosition_func | Returns the position vector |
| CPow | Raises the output of a Qpoint_func to a user-specified power |
| CPrescribed_energy | Prescribes the specific energy but doesn't touch the heat flux |
| CPrescribed_heat_flux | Prescribes the heat flux but doesn't touch the energy |
| CPressure | Computes (static) pressure |
| CPressure_outflow | Sets pressure on outflow boundaries |
| CPressure_stress | Computes inviscid surface force per unit area (i.e. pressure times unit normal) |
| CPrinter | Abstract base class for handling different variations of printing things for user |
| CPrinter_set | A complete set of printers that support messages with various purposes |
| CPtr_base | Abstract base class for implementing mutually-connected pointers |
| CQpoint_expr | Evaluates a structured expression |
| CQpoint_func | Represents a function which can be evaluated at quadrature points |
| CRandom_func | Returns a random output uniformly distributed in a user-specified range |
| CReciprocal_list | Like Reciprocal_ptr, put it can be connected with multiple partners |
| CReciprocal_ptr | Implements pairs of reciprocally-connected pointers |
| CRecord | Returns Element::record |
| ►CRefined_connection | |
| CFine_connection | Connection subclass to which will represent the connections for the numerical flux calculation |
| CRefined_face | |
| CRiemann_invariants | A freestream boundary condition that sets only the ingoing characteristics |
| CRingleb | Steady-state solution for Ringleb flow |
| CRingleb_errsq | Squared error metric for computing \(L^2\) error of Ringleb flow |
| CRow_index | Facilitates the process of iterating through all rows along a particular dimension |
| CRow_rw | "row read/write" |
| CScaled | Scales a function of a single variable |
| CSequence | An interface for general sequence-type containers |
| CSimplex_geom | Represents discrete geometry composed of simplices |
| ►CSimplex_geom_nd | Abstract base class for Simplex_geom exposing the dimensionality-independent functionality |
| CIntersections | |
| CSlice | |
| CSod | Initial consition for classic Sod problem |
| CSolver | The main class that basically runs everything |
| CSpacetime_expr | Evaluates a structured expression |
| CSpacetime_func | Represents a function of position and time |
| ►CSpatial | |
| CFace_permutation | |
| CLocal | Performs the update to the element state after the shared numerical flux has been computed |
| CMax_dt | Compute the maximum stable time step |
| CNeighbor | Computes the shared numerical flux at the element interfaces |
| CNeighbor_reconcile | |
| CProlong_refined | |
| CReconcile_ldg_flux | Account for the difference between the real and numerical viscous fluxes to enforce conservation |
| CRestrict_refined | |
| CWrite_face | Extrapolates the values in the interior of an element to the faces |
| CSpatial_gaussian | Multivariate Gaussian distribution in terms of spatial coordinates normalized to evaluate to 1 at the zero vector |
| CStab_art_visc | |
| CStab_indicator | Useful for detecting elements that require stabilization |
| CStag_pres | Computes stagnation pressure |
| CState_from_spacetime | A class of Spacetime_funcs whose output is a state vector |
| CState_variables | A function that simply gives you back the state variables. Useful for visualization and conservation checking |
| ►CStopwatch | A class for conveniently measuring execution time |
| COperator | RAII-style operation of a stopwatch |
| CStopwatch_tree | A tree structure of Stopwatch objects |
| CStorage_params | Parameters of the numerical scheme that are necessary to determine storage requirements |
| ►CStream_printer | Prints to a std::ostream |
| CFormat | For passing text formatting parameters to Stream_printer::Stream_printer |
| CStruct_expr | Evaluates a structured expression in HIL |
| CSurface_func | A class of functions that can be evaluated at a point on a surface, without reference to a Boundary_connection object |
| CSurface_geom | Represents a surface geometry implicitly for meshing |
| CTask_message | Prints messages like "message... done" |
| ►CTecplot_file | Wrapper for Tecplot API |
| CLine_segments | Represents an arbitrary number of line segments |
| CStructured_block | Represents a single block of structured data. Call write() exactly once before destructing |
| CTriangles | Represents a collection of triangles in 3D |
| CUnstructured | |
| CZone | |
| CThermal_bc | Thermal component of a No_slip wall boundary condition |
| CThermal_equilibrium | Stipulates that the wall is in thermal equilibrium based on a 1D heat equation |
| CTime_step_scale_func | Fetches the value of the Element::time_step_scale member |
| CTransport_model | |
| CTree | Bin/quad/octree data structure |
| CTyped_bound_connection | |
| CUncertainty | Function to fetch the value of the uncertainty member of the Element |
| CVector_view | Provides a view of an existing container (e.g., std::vector) as a Sequence |
| CVelocity | Computes velocity vector |
| ►CVertex | Represents a vertex in a deformed grid |
| CNon_transferable_ptr | A pointer class which is not transferred by Vertex::eat |
| CTransferable_ptr | A pointer class which can be transferred by Vertex::eat |
| CView_by_type | |
| ►CVis_data | |
| CContour | Stores data representing a contour line/surface |
| CViscous_stress | Computes viscous stress at surface |
| CVisualizer | General interface for writing visualization data in different file formats |
| CXdmf_wrapper | Lightweight wrapper for XDMF API for block-structured data |
| ►Nhexedpy | Root namespace for Python modules |
| ►Nbuild_utils | Library for creating build scripts |
| C_Options | |
| CBoolean | |
| CBoost | |
| CBuildable | |
| CBuilder | |
| CC_project | |
| CCatch2 | |
| CCompile | |
| CCompiler | |
| CCompleted | |
| CConfigure | |
| CCopy | |
| CDeliverable | |
| CDict_wrapper | |
| CDoxygen | |
| CDummy | |
| CEigen | |
| CExtract | |
| CFile | |
| CHDF5 | |
| CInstall_wheel | |
| CLibxml2 | |
| CLibxml2_base | |
| CLink | |
| COcct | |
| COption | |
| CPip | |
| CPrefices | |
| CPython_package | |
| CPython_script | |
| CSubprocess | |
| CUnion | |
| CWget | |
| CXdmf | |
| ►Nutils | A Python module with random tools that are useful for Hexed simulations |
| CHistory_plot | Creates a real-time, interactive plot of the convergence history |