| C__mast_multiphysics_petsc_shell_context | |
| ►CMAST::AssemblyElemOperations | |
| ►CMAST::ComplexAssemblyElemOperations | |
| CMAST::FrequencyDomainLinearizedComplexAssemblyElemOperations | |
| ►CMAST::EigenproblemAssemblyElemOperations | |
| CMAST::StructuralBucklingEigenproblemElemOperations | |
| CMAST::StructuralModalEigenproblemAssemblyElemOperations | |
| CMAST::FluidStructureAssemblyElemOperations | |
| ►CMAST::NonlinearImplicitAssemblyElemOperations | |
| CMAST::HeatConductionNonlinearAssemblyElemOperations | |
| CMAST::StructuralNonlinearAssemblyElemOperations | |
| ►CMAST::TransientSolverBase | |
| ►CMAST::SecondOrderNewmarkTransientSolver | This class implements the Newmark solver for solution of a second-order ODE |
| CMAST::GeneralizedAlphaTransientSolver | This class implements the generalized alpha method for solution of a second-order ODE |
| CMAST::StabilizedFirstOrderNewmarkTransientSensitivitySolver | This solver implements the stabilized sensitivity analysis solver for chaotic systems where the linearized system can be unstable |
| ►CMAST::OutputAssemblyElemOperations | This provides the base class for definitin of element level contribution of output quantity in an analysis |
| CMAST::ComplianceOutput | Computes the compliance as |
| CMAST::IntegratedForceOutput | |
| CMAST::LevelSetPerimeter | Computes the perimeter of a level set boundary as a volume integral
, where is the level set function, is the approximation to the Dirac delta function implemented in LevelSetElementBase |
| CMAST::LevelSetVolume | |
| ►CMAST::StressStrainOutputBase | Data structure provides the mechanism to store stress and strain output from a structural analysis |
| CMAST::KSStressStrainOutput | This implements the computation of KS-constraint aggregation functional for the stress constraint |
| CMAST::SmoothRampStressStrainOutput | This implements the computation of smooth ramp constraint aggregation functional for the stress constraint |
| CMAST::StressTemperatureAdjoint | The stress and thermoelastic analysis are dependent on temperature |
| CMAST::SurfaceIntegratedPressureOutput | The surface integrated pressure calculation in the fluid element will provide a force vector for the integrated load |
| ►CMAST::TransientAssemblyElemOperations | |
| CMAST::ConservativeFluidTransientAssemblyElemOperations | |
| CMAST::HeatConductionTransientAssemblyElemOperations | |
| CMAST::LevelSetTransientAssemblyElemOperations | |
| CMAST::StructuralTransientAssemblyElemOperations | |
| ►CMAST::BendingOperator | |
| ►CMAST::BendingOperator1D | Bending strain operator for 1D element |
| CMAST::BernoulliBendingOperator | |
| CMAST::TimoshenkoBendingOperator | |
| ►CMAST::BendingOperator2D | Bending strain operator for 1D element |
| CMAST::DKTBendingOperator | |
| CMAST::MindlinBendingOperator | |
| CMAST::ComplexSolverBase | Uses a Gauss-Siedel method to solve the complex system of equations for a system |
| ►CComputeResidualandJacobian | |
| ►CMAST::AssemblyBase | |
| CMAST::ComplexAssemblyBase | |
| ►CMAST::EigenproblemAssembly | Assembles the system of equations for an eigenproblem of type |
| CMAST::LevelSetEigenproblemAssembly | |
| CMAST::StructuralBucklingEigenproblemAssembly | |
| ►CMAST::NonlinearImplicitAssembly | |
| CMAST::LevelSetNonlinearImplicitAssembly | |
| ►CMAST::StressAssembly | |
| CMAST::LevelSetStressAssembly | |
| ►CMAST::StructuralFluidInteractionAssembly | |
| CMAST::FSIGeneralizedAeroForceAssembly | |
| ►CMAST::TransientAssembly | |
| CMAST::LevelSetReinitializationTransientAssembly | |
| ►CComputeVectorSubspace | |
| CMAST::StructuralNearNullVectorSpace | This defines the near-null space of a structural finite element model, which is composed of the six rigid-body nodes |
| ►CConstraint | |
| ►CMAST::LevelSetConstrainDofs | Constrains the dofs based on level set function |
| CMAST::IndicatorFunctionConstrainDofs | Constrains the dofs based on level set function and indicator function |
| ►CMAST::ContinuationSolverBase | Equation set is: the N-R updates are calculated such that
This equation is solved using Schur-factorization so that the disciplinary linear solver can be used |
| CMAST::ArclengthContinuationSolver | Constraint equation is defined along the path as
where, is the solution, is the load parameter, and is the chord length |
| CMAST::PseudoArclengthContinuationSolver | The constraint equation is defined along the path as
where, , is the solution, is the load parameter, is the predictor based on the search direction |
| CMAST::StressStrainOutputBase::Data | This class provides a mechanism to store stress/strain values, their derivatives and sensitivity values corresponding to a specific quadrature point on the element |
| ►CMAST::DoFCouplingBase | This provides a base class to couple degrees-of-freedom within a single system |
| CMAST::KinematicCoupling | This constrains the slave nodes to be kinematically constrained to the master node |
| ►CMAST::ElementBase | This is the base class for elements that implement calculation of finite element quantities over the domain and sides of a geometric element |
| ►CMAST::ConservativeFluidElementBase | This class provides the necessary functionality for spatial discretization of the conservative fluid equations |
| CMAST::FrequencyDomainLinearizedConservativeFluidElem | |
| CMAST::HeatConductionElementBase | This element implements the Galerkin discretization of the heat conduction problem
with the flux provided on the boundary with Neumann boundary conditions |
| CMAST::LevelSetElementBase | |
| ►CMAST::StructuralElementBase | |
| ►CMAST::BendingStructuralElem | |
| CMAST::StructuralElement1D | |
| CMAST::StructuralElement2D | |
| CMAST::StructuralElement3D | |
| CMAST::AssemblyBase::ElemParameterDependence | Inherited objects from this class can be provided by the user provide assessment of whether or not an element is influenced by a give parameter |
| ►CMAST::FEBase | |
| CMAST::SubCellFE | This class specializes the MAST::FEBase class for level-set applications where integration is to be performed on a sub-cell inside an element |
| CMAST::FEMOperatorMatrix | |
| CMAST::FilterBase | Creates a geometric filter for the level-set design variables |
| CMAST::FlightCondition | |
| ►CMAST::FluidElemBase | This class provides the necessary functions to evaluate the flux vectors and their Jacobians for both inviscid and viscous flows |
| CMAST::ConservativeFluidElementBase | This class provides the necessary functionality for spatial discretization of the conservative fluid equations |
| ►CMAST::FlutterRootBase | |
| CMAST::PKFlutterRoot | |
| CMAST::TimeDomainFlutterRoot | |
| CMAST::UGFlutterRoot | |
| ►CMAST::FlutterRootCrossoverBase | |
| CMAST::PKFlutterRootCrossover | |
| CMAST::TimeDomainFlutterRootCrossover | |
| CMAST::UGFlutterRootCrossover | |
| ►CMAST::FlutterSolutionBase | |
| CMAST::PKFlutterSolution | |
| CMAST::TimeDomainFlutterSolution | |
| CMAST::UGFlutterSolution | |
| ►CMAST::FlutterSolverBase | |
| CMAST::PKFlutterSolver | |
| CMAST::TimeDomainFlutterSolver | This implements a solver for a single parameter instability problem, for example a flutter solver where flight speed is the primary parameter |
| CMAST::UGFlutterSolver | This implements a solver for a single parameter instability problem, for example a flutter solver where reduced frequency is the primary parameter |
| ►CMAST::FunctionBase | |
| ►CMAST::FieldFunction< Complex > | |
| CMAST::FrequencyDomainPressureFunction | |
| ►CMAST::FieldFunction< ComplexVectorX > | |
| CMAST::ComplexMeshFieldFunction | This provides a wrapper FieldFunction compatible class that interpolates the solution using libMesh's MeshFunction class |
| ►CMAST::NormalRotationFunctionBase< ComplexVectorX > | |
| CMAST::ComplexNormalRotationMeshFunction | |
| ►CMAST::FieldFunction< Real > | |
| CMAST::ConstantFieldFunction | |
| CMAST::FrequencyFunction | |
| CMAST::Multilayer1DSectionProperty::LayerOffset | |
| CMAST::Multilayer2DSectionProperty::LayerOffset | |
| CMAST::PistonTheoryPressure | |
| CMAST::PistonTheoryPressureXDerivative | |
| CMAST::PistonTheoryPressureXdotDerivative | |
| CMAST::PressureFunction | |
| CMAST::Solid1DSectionProperty::Area | |
| CMAST::Solid1DSectionProperty::AreaYMoment | Calculates the area moment about the Y-axis due to an offset along the Z-axis |
| CMAST::Solid1DSectionProperty::AreaZMoment | Calculates the area moment about the Z-axis due to an offset along the Y-axis |
| CMAST::Solid1DSectionProperty::PolarInertia | |
| CMAST::Solid1DSectionProperty::TorsionalConstant | |
| ►CMAST::FieldFunction< RealMatrixX > | |
| ►CMAST::CoordinateBase | Provides the transformation matrix T to transform vector from the orientation provided in this matrix, to one in the global basis |
| CMAST::BasisMatrixCoordinate | Provides the transformation matrix T to transform vector from the orientation provided in this matrix, to one in the global basis |
| CMAST::PolarCoordinate | Defines a polar coordinate system with the radius and obtained from the two parameters provided in the constructor |
| CMAST::IsotropicElementProperty3D::InertiaMatrix | |
| CMAST::IsotropicElementProperty3D::PrestressAMatrix | |
| CMAST::IsotropicElementProperty3D::StiffnessMatrix | |
| CMAST::IsotropicElementProperty3D::ThermalCapacitanceMatrix | |
| CMAST::IsotropicElementProperty3D::ThermalConductanceMatrix | |
| CMAST::IsotropicElementProperty3D::ThermalExpansionMatrix | |
| CMAST::IsotropicMaterialProperty::InertiaMatrix3D | |
| CMAST::IsotropicMaterialProperty::StiffnessMatrix1D | |
| CMAST::IsotropicMaterialProperty::StiffnessMatrix2D | |
| CMAST::IsotropicMaterialProperty::StiffnessMatrix3D | |
| CMAST::IsotropicMaterialProperty::ThermalCapacitanceMatrix | |
| CMAST::IsotropicMaterialProperty::ThermalConductanceMatrix | |
| CMAST::IsotropicMaterialProperty::ThermalExpansionMatrix | |
| CMAST::IsotropicMaterialProperty::TransverseShearStiffnessMatrix | |
| CMAST::Multilayer1DSectionProperty::Matrix | |
| CMAST::Multilayer2DSectionProperty::Matrix | |
| CMAST::OrthotropicMaterialProperty::InertiaMatrix3D | |
| CMAST::OrthotropicMaterialProperty::StiffnessMatrix1D | |
| CMAST::OrthotropicMaterialProperty::StiffnessMatrix2D | |
| CMAST::OrthotropicMaterialProperty::StiffnessMatrix3D | |
| CMAST::OrthotropicMaterialProperty::ThermalCapacitanceMatrix | |
| CMAST::OrthotropicMaterialProperty::ThermalConductanceMatrix | |
| CMAST::OrthotropicMaterialProperty::ThermalExpansionMatrix | |
| CMAST::OrthotropicMaterialProperty::TransverseShearStiffnessMatrix | |
| CMAST::OrthotropicProperty3D::InertiaMatrix | |
| CMAST::OrthotropicProperty3D::PrestressAMatrix | |
| CMAST::OrthotropicProperty3D::StiffnessMatrix | |
| CMAST::OrthotropicProperty3D::ThermalCapacitanceMatrix | |
| CMAST::OrthotropicProperty3D::ThermalConductanceMatrix | |
| CMAST::OrthotropicProperty3D::ThermalExpansionMatrix | |
| CMAST::Solid1DSectionProperty::AreaInertiaMatrix | Calculates the 2x2 matrix of area inertia for the section with individual entries as |
| CMAST::Solid1DSectionProperty::BendingStiffnessMatrix | |
| CMAST::Solid1DSectionProperty::ExtensionBendingStiffnessMatrix | |
| CMAST::Solid1DSectionProperty::ExtensionStiffnessMatrix | |
| CMAST::Solid1DSectionProperty::InertiaMatrix | |
| CMAST::Solid1DSectionProperty::PrestressAMatrix | |
| CMAST::Solid1DSectionProperty::PrestressBMatrix | |
| CMAST::Solid1DSectionProperty::ThermalCapacitanceMatrix | |
| CMAST::Solid1DSectionProperty::ThermalConductanceMatrix | |
| CMAST::Solid1DSectionProperty::ThermalExpansionAMatrix | |
| CMAST::Solid1DSectionProperty::ThermalExpansionBMatrix | |
| CMAST::Solid1DSectionProperty::TransverseStiffnessMatrix | |
| CMAST::Solid2DSectionProperty::BendingStiffnessMatrix | |
| CMAST::Solid2DSectionProperty::ExtensionBendingStiffnessMatrix | |
| CMAST::Solid2DSectionProperty::ExtensionStiffnessMatrix | |
| CMAST::Solid2DSectionProperty::InertiaMatrix | |
| CMAST::Solid2DSectionProperty::PrestressAMatrix | |
| CMAST::Solid2DSectionProperty::PrestressBMatrix | |
| CMAST::Solid2DSectionProperty::ThermalCapacitanceMatrix | |
| CMAST::Solid2DSectionProperty::ThermalConductanceMatrix | |
| CMAST::Solid2DSectionProperty::ThermalExpansionAMatrix | |
| CMAST::Solid2DSectionProperty::ThermalExpansionBMatrix | |
| CMAST::Solid2DSectionProperty::TransverseStiffnessMatrix | |
| ►CMAST::FieldFunction< RealVectorX > | |
| CMAST::LevelSetBoundaryVelocity | |
| CMAST::MeshFieldFunction | This provides a wrapper FieldFunction compatible class that interpolates the solution using libMesh's MeshFunction class |
| ►CMAST::NormalRotationFunctionBase< RealVectorX > | |
| CMAST::NormalRotationMeshFunction | |
| ►CMAST::FieldFunction< ValType > | This creates the base class for functions that have a saptial and temporal dependence, and provide sensitivity operations with respect to the functions and parameters |
| CMAST::NormalRotationFunctionBase< ValType > | This uses the displacement gradient to calculate the rotation in a given surface normal |
| ►CMAST::Parameter | This is a scalar function whose value can be changed and one that can be used as a design variable in sensitivity analysis and optimization across the code |
| CMAST::LevelSetParameter | This defines a parameter that is a level set function and stores a pointer to the node in the level-set mesh whose value is defiend by this parameter |
| ►CFunctionBase | |
| CMAST::StructuralModes | |
| ►CMAST::FunctionSetBase | Methods to store property values |
| ►CMAST::BoundaryConditionBase | |
| CMAST::DirichletBoundaryCondition | |
| CMAST::PistonTheoryBoundaryCondition | |
| CMAST::PointLoadCondition | This class allows for the specification of load associated with specified nodes in a user-provided set |
| ►CMAST::ElementPropertyCardBase | |
| ►CMAST::ElementPropertyCard1D | |
| CMAST::Multilayer1DSectionElementPropertyCard | |
| CMAST::Solid1DSectionElementPropertyCard | |
| ►CMAST::ElementPropertyCard2D | |
| CMAST::Multilayer2DSectionElementPropertyCard | |
| CMAST::Solid2DSectionElementPropertyCard | |
| CMAST::IsotropicElementPropertyCard3D | |
| CMAST::OrthotropicElementPropertyCard3D | |
| ►CMAST::MaterialPropertyCardBase | |
| CMAST::IsotropicMaterialPropertyCard | |
| CMAST::OrthotropicMaterialPropertyCard | |
| CMAST::GasProperty | |
| ►CMAST::GeomElem | This class acts as a wrapper around libMesh::Elem for the purpose of providing a uniform interface for cases where: |
| CMAST::LevelSetIntersectedElem | This class inherits from MAST::GeomElem and provides an interface to initialize FE objects on sub-elements obtained from intersection of level-set function with a reference element |
| CMAST::KinematicCouplingConstraint | This object stores the information about the coupling of nodes |
| CMAST::LAPACK_DGEEV | |
| CMAST::LAPACK_DGGEV | |
| ►CMAST::LAPACK_ZGGEV_Base | |
| CMAST::LAPACK_ZGGEV | |
| CMAST::LAPACK_ZGGEVX | |
| CMAST::LevelSetInterfaceDofHandler | |
| CMAST::LevelSetIntersection | |
| CMAST::MaterialPatch | A patch is defines as the set of elements sharing a node |
| CMatrixType< ValType > | |
| CMatrixType< Complex > | |
| CMatrixType< Real > | |
| CMAST::MeshCouplingBase | |
| ►CNonlinearImplicitSystem | |
| ►CMAST::NonlinearSystem | This class implements a system for solution of nonlinear systems |
| CMAST::StructuralSystem | This class implements a system for quasi-static analysis of nonlinear structures |
| ►CMAST::OptimizationInterface | Provides the basic interface API for classes the provide implement optimization problems |
| CMAST::DOTOptimizationInterface | |
| CMAST::GCMMAOptimizationInterface | |
| CMAST::NLOptOptimizationInterface | |
| CMAST::NPSOLOptimizationInterface | |
| ►CParallelObject | |
| CMAST::FunctionEvaluation | |
| CMAST::MultiphysicsNonlinearSolverBase | |
| ►CMAST::PhysicsDisciplineBase | |
| CMAST::ConservativeFluidDiscipline | |
| CMAST::LevelSetDiscipline | |
| CMAST::TransientAssembly::PostAssemblyOperation | User-provided object to perform actions after assembly and before returning to the solver |
| CMAST::NonlinearImplicitAssembly::PostAssemblyOperation | User-provided object to perform actions after assembly and before returning to the solver |
| CMAST::MultiphysicsNonlinearSolverBase::PreResidualUpdate | This class provides the interface that, if provided, will be called to update any data structures before computation of residual/Jacobian at an iterate |
| CMAST::PrimitiveSolution | Class defines the conversion and some basic operations on primitive fluid variables used in calculation of flux, Jacobians, etc |
| ►CShellMatrix | |
| CMAST::BasisMatrix< T > | |
| ►CSlepcEigenSolver | |
| CMAST::SlepcEigenSolver | This class inherits from libMesh::SlepcEigenSolver<Real> and implements a method for retriving the real and imaginary components of the eigenvector, which the libMesh interface does not provide |
| CMAST::SmallPerturbationPrimitiveSolution< ValType > | Class defines basic operations and calculation of the small disturbance primitive variables |
| ►CMAST::AssemblyBase::SolverMonitor | |
| CMAST::LevelSetVoidSolution | This will compute the solution at the interface under the assumption of zero surface normal flux |
| CMAST::StructuralAssembly | This class provides some routines that are common to structural assembly routines |
| CMAST::FlutterSolverBase::SteadySolver | Abstract class defines the interface to provide the steady-state solution |
| ►CMAST::SystemInitialization | |
| CMAST::ConservativeFluidSystemInitialization | |
| CMAST::HeatConductionSystemInitialization | |
| CMAST::LevelSetSystemInitialization | |
| CMAST::StructuralSystemInitialization | |
| CVectorType< ValType > | |
| CVectorType< Complex > | |
| CVectorType< Real > | |