CIkarus::AlgoInfo | Additional information about the TrustRegion algorithm |
CIkarus::ArcLength | Structure representing the subsidiary function for the standard arc-length method |
CIkarus::ArrudaBoyceMatParameters | < Structure representing material parameters for the Arrudy-Boyce material model |
CIkarus::Materials::ArrudaBoyceT< ST_ > | Implementation of the ArrudaBoyce material model (also referred as Eight-Chain model) |
CIkarus::AssemblerManipulator< A, Ass > | The AssemblerManipulator defines a decorator for the assemblers that helps to manipulate the assembled quantities |
►CBase | |
CIkarus::Vtk::Writer< AS, DC, Base > | Manages writing results using VTK, based on assembler and data collector |
CIkarus::BasisHandler< PB > | Wrapper class for a hierarchical basis constructed from a pre-basis |
CIkarus::Materials::BlatzKoT< ST_ > | Implementation of the Blatz-Ko material model |
CIkarus::Broadcaster< Args > | |
►CIkarus::Broadcaster< Signatures > | |
►CIkarus::Broadcasters< void(ControlMessages), void(ControlMessages, const std::string &), void(ControlMessages, int, const std::string &), void(ControlMessages, int, double), void(ControlMessages, const ControlRoutineStateType< F > &), Args... > | |
CIkarus::ControlRoutineBase< F, S, Args > | Base for all control routines. Defines the message interface that can be broadcasted to listeners |
►CIkarus::Broadcasters< void(ControlMessages), void(ControlMessages, const std::string &), void(ControlMessages, int, const std::string &), void(ControlMessages, int, double), void(ControlMessages, const ControlRoutineStateType< NLS::DifferentiableFunction > &), Args... > | |
►CIkarus::ControlRoutineBase< NLS::DifferentiableFunction > | |
CIkarus::LoadControl< NLS > | The LoadControl control routine increases the parameter of the fe requirements given in run function and solves the corresponding differentiable function f for its root and calls a nonlinear solver. controlroutines This class represents the LoadControl control routine. It increments the parameter of the fe requirement and utilizes a nonlinear solver, such as Newton's method, to solve the resulting system at each step |
►CIkarus::Broadcasters< void(NonLinearSolverMessages), void(NonLinearSolverMessages, double), void(NonLinearSolverMessages, int), void(NonLinearSolverMessages, const NonlinearSolverStateType< F > &), Args... > | |
►CIkarus::NonlinearSolverBase< F > | |
CIkarus::NewtonRaphson< F, LS, UF > | Implementation of the Newton-Raphson method for solving nonlinear equations |
CIkarus::NewtonRaphsonWithSubsidiaryFunction< F, LS, UF > | Newton-Raphson solver with subsidiary function |
CIkarus::TrustRegion< F, preConditioner, UF > | Trust Region solver for non-linear optimization problems |
CIkarus::NonlinearSolverBase< F, Args > | Base for all nonlinear solvers. Defines the message interface that can be broadcasted to listeners |
►CIkarus::Broadcasters< void(ControlMessages), void(ControlMessages, const std::string &), void(ControlMessages, int, const std::string &), void(ControlMessages, int, double), void(ControlMessages, const PathFollowingStateType< NLS::DifferentiableFunction > &), Args... > | |
►CIkarus::ControlRoutineBase< NLS::DifferentiableFunction, PathFollowingStateType< NLS::DifferentiableFunction > > | |
CIkarus::PathFollowing< NLS, PF, ASS > | The PathFollowing control routine for path-following analysis |
CIkarus::Broadcasters< Signatures > | Fuses together multiple function signatures that can be emitted by one broadcaster. A broadcaster has to be a derived class of this class |
CIkarus::Broadcaster< void(Args...)> | Implements a Broadcaster for a specific function signature with return type void |
CIkarus::BulkModulusAndLamesFirstParameter | Structure representing Lame's first parameter and shear modulus |
CIkarus::traits::ChangeArgTypeAtPos< Func, Pos, NewType > | Main function to wrap the type at position pos in a std::function |
CIkarus::utils::CheckFlags | Struct to hold flags for function checks |
►Cstd::conditional_t | |
CIkarus::EnhancedAssumedStrains< PreFE, FE, ES > | Wrapper class for using Enhanced Assumed Strains (EAS) with displacement based elements |
CIkarus::ControlInformation | Structure containing information about the control results |
CIkarus::ControlRoutineFactory | A factory class for creating control routines |
CIkarus::ControlRoutineState< D > | State for control routines |
CPython::Conversion< autodiff::Real< order, T > > | Conversion specialization for autodiff::Real type |
CIkarus::ConvertLameConstants< ValuePair > | Conversion utility for Lame's constants |
CIkarus::DefaultMembraneStrain | |
CIkarus::Vtk::DefaultVTKWriterManager< GV > | Manages the default template parameter for the Vtk::Writer |
CIkarus::DeriveSizeType< class > | A helper struct to derive the SizeType of the underlying container |
CIkarus::DeriveSizeType< std::vector< bool > > | |
CIkarus::DeriveSizeType< T > | |
CIkarus::Materials::Deviatoric< DF > | This is the interface implementation for the deviatoric part of a hyperelastic material. It is intended to be used with the hyperelastic material model |
CIkarus::Materials::DeviatoricInvariants< PS > | Implementation of the deviatoric invariants and its derivatives |
CIkarus::DifferentiableFunctionFactory | |
►CDune::Functions::DifferentiableFunctionFromCallables | |
CIkarus::DifferentiableFunction< Range(D), DerivativeTraits, F, FF... > | DifferentiableFunction is a class taking several callables. The function are assumed to be derivatives of each other w.r.t. the argument |
CIkarus::DirichletValues< B, FC > | Class for handling Dirichlet boundary conditions in Ikarus |
CIkarus::DisplacementControl | Structure representing the subsidiary function for the displacement control method |
CIkarus::EAS::DisplacementGradient | A struct computing the value, first and second derivatives of the Green-Lagrange strain tensor (in Voigt notation), where the displacement gradient is enhanced |
CIkarus::EAS::DisplacementGradientTransposed | A struct computing the value, first and second derivatives of the Green-Lagrange strain tensor (in Voigt notation), where the transpose of the displacement gradient (pre-multiplied with deformation gradient at the center of the element) is enhanced |
CIkarus::EAS::EASVariant< ES, GEO > | Wrapper around the EAS variant, contains helper functions |
CIkarus::EAS::EASVariant< ES, Geometry > | |
CEigen::EigenBase< Derived > | |
CIkarus::EnhancedAssumedStrainsPre< ES > | A PreFE struct for Enhanced Assumed Strains |
CIkarus::EAS::EX< GEO, ess > | Interface for displacement-based EAS elements, where linear or Green-Lagrange strains are enhanced |
►CIkarus::EAS::EX< GEO, 0 > | |
CIkarus::EAS::E0< GEO > | Dummy struct for displacement-based EAS elements, i.e. 0 enhanced modes |
►CIkarus::EAS::EX< GEO, 11 > | |
CIkarus::EAS::E11< GEO > | Structure representing EAS for Q2 with 11 enhanced strains |
►CIkarus::EAS::EX< GEO, 21 > | |
CIkarus::EAS::E21< GEO > | Structure representing EAS for H1 with 21 enhanced strains |
►CIkarus::EAS::EX< GEO, 4 > | |
CIkarus::EAS::E4< GEO > | E4 structure for EAS with linear strains and 4 enhanced modes |
►CIkarus::EAS::EX< GEO, 5 > | |
CIkarus::EAS::E5< GEO > | Structure representing EAS for Q1 with 5 enhanced strains |
►CIkarus::EAS::EX< GEO, 7 > | |
CIkarus::EAS::E7< GEO > | Structure representing EAS for Q1 with 7 enhanced strains |
►CIkarus::EAS::EX< GEO, 9 > | |
CIkarus::EAS::E9< GEO > | Structure representing EAS for H1 with 9 enhanced strains |
►Cstd::false_type | |
CIkarus::Vtk::IsStructured< G > | Meta type to check whether a grid is structured, inherits from false_type |
CIkarus::traits::hasType< T, Tuple > | Type trait to check if a specified type is present in a tuple |
CIkarus::traits::isSharedPtr< T > | Type trait to check if a type is a isSharedPtr |
CIkarus::traits::isUniquePtr< T > | Type trait to check if a type is a isUniquePtr |
CIkarus::FEFactory< BH, SK, useFlat, useEigenRef > | FEFactory is a convenient wrapper to forward arguments to PreFE and create and construct a factory of finite elements |
►CFEImpl | |
CIkarus::AutoDiffFE< FEImpl, forceAutoDiff > | AutoDiffFE class, an automatic differentiation wrapper for finite elements |
►CIkarus::Impl::FEInit< PreFE, FE< PreFE, Skills... > > | |
CIkarus::FE< PreFE, Skills > | FE class is a base class for all finite elements |
CIkarus::FERequirements< sol, para, SV, PM > | Class representing the requirements for finite element calculations |
CIkarus::FETraits< BH, useRef, useFlat > | Traits for handling finite elements |
CDune::FieldVector< K, N > | |
CDune::FieldVector< double, 2 > | |
►CIkarus::FlatAssemblerBase< FEC, DV > | The FlatAssemblerBase takes care of common subtasks done by flat assemblers |
►CIkarus::ScalarFlatAssembler< FEC, DV > | ScalarFlatAssembler assembles scalar quantities |
►CIkarus::VectorFlatAssembler< FEC, DV > | VectorFlatAssembler assembles vector quantities using a flat basis Indexing strategy |
CIkarus::DenseFlatAssembler< FEC, DV > | DenseFlatAssembler assembles matrix quantities using a flat basis Indexing strategy. The matrix is stored in a dense matrix format. This format is exploited during the assembly process |
CIkarus::SparseFlatAssembler< FEC, DV > | SparseFlatAssembler assembles matrix quantities using a flat basis Indexing strategy. The matrix is stored in a sparse matrix format. This format is exploited during the assembly process |
CIkarus::FlatIndexMergingStrategy< IMS > | Define the flat index-merging strategy for a given strategy IMS |
CIkarus::FlatIndexMergingStrategy< Dune::Functions::BasisFactory::BlockedInterleaved > | |
CIkarus::FlatIndexMergingStrategy< Dune::Functions::BasisFactory::BlockedLexicographic > | |
CIkarus::FlatPreBasis< PreBasis > | Transform a PreBasis into one with flat index-merging strategyThis utility takes a pre-basis and converts recursively all index-merging strategies into their flat analog, i.e. BlockedInterleaved is converted into FlatInterleaved and BlockedLexicographic is transformed into FlatLexicographic |
CIkarus::FlatPreBasis< Dune::Functions::CompositePreBasis< IMS, SPB... > > | |
CIkarus::FlatPreBasis< Dune::Functions::PowerPreBasis< IMS, SPB, C > > | |
CIkarus::traits::FunctionTraits< T, typename > | Type trait for extracting information about functions |
CIkarus::GentMatParameters | < Structure representing material parameters for the Gent material model |
CIkarus::Materials::GentT< ST_ > | Implementation of the Gent material model |
CIkarus::EAS::GreenLagrangeStrain | A struct computing the value, first and second derivatives of the Green-Lagrange strain tensor (in Voigt notation), where the Green-Lagrange strain itself is enhanced |
CIkarus::EAS::HX< GEO, ess > | Interface for displacement-based EAS elements, where displacement gradient is enhanced |
►CIkarus::EAS::HX< GEO, 0 > | |
CIkarus::EAS::H0< GEO > | Dummy struct for displacement-based EAS elements, i.e. 0 enhanced modes, where displacement gradient is enhanced |
►CIkarus::EAS::HX< GEO, 4 > | |
CIkarus::EAS::H4< GEO > | H4 struct for EAS with 4 enhanced modes |
►CIkarus::EAS::HX< GEO, 9 > | |
CIkarus::EAS::H9< GEO > | H9 struct for EAS with 9 enhanced modes |
CIkarus::ResultEvaluators::HydrostaticStress | Struct for calculating hydrostatic stress |
CIkarus::IkarusInstance | Singleton class representing an instance of the Ikarus framework |
CIkarus::traits::Index< T, Tuple > | Type trait to get the index of a type in a tuple |
CIkarus::Materials::InvariantBasedT< ST_, n > | Implementation of the InvariantBased material model |
CIkarus::AdaptiveStepSizing::IterationBased | The IterationBased strategy for adaptive step sizing |
►CIterativeSolverBase | |
CEigen::TruncatedConjugateGradient< std::decay_t< HessianType >, Eigen::Lower|Eigen::Upper, PreConditionerType > | |
CEigen::TruncatedConjugateGradient< M, upLo, PC > | Iterative solver for solving linear systems using the truncated conjugate gradient method |
CIkarus::KirchhoffLoveShell< PreFE, FE >::KinematicVariables< ST > | A structure representing kinematic variables |
CIkarus::Truss< PreFE, FE >::KinematicVariables< ST > | A structure representing kinematic variables |
CIkarus::KirchhoffLoveShellPre | A PreFE struct for Kirchhoff-Love shell elements |
CIkarus::KlArgs | A struct containing information about the Youngs Modulus, Poisson's ratio and the thickness for the Kirchhoff-Love shell element |
CIkarus::LamesFirstParameterAndShearModulus | |
CIkarus::LinearElasticPre< MAT > | A PreFE struct for linear elastic elements |
CIkarus::LinearSolverTemplate< ST > | A type-erased class which wraps most of the linear solvers available in Eigen |
CIkarus::EAS::LinearStrain | A struct computing the value, first and second derivatives of the linear strain tensor (in Voigt notation), where the linear strain itself is enhanced |
►CIkarus::Listener | |
►CIkarus::FEMixin< PreFE, Skills... > | |
CIkarus::FE< PreFE, Skills > | FE class is a base class for all finite elements |
CIkarus::ControlLogger | ControlLogger class for logging control messages |
CIkarus::ControlSubsamplingVertexVTKWriter< B > | ControlSubsamplingVertexVTKWriter class for writing VTK files with subsampling based on control messages |
CIkarus::FEMixin< PreFE, Skills > | CRTP mixin class for finite elements with additional skills |
CIkarus::GenericListener< M > | GenericListener class for observing specific messages. This class template implements an listener for a specific message type |
CIkarus::NonLinearSolverLogger | Implementation of an observer for logging non-linear solvers.This class inherits from the IObserver class and provides specific implementations for updating based on NonLinearSolverMessages |
CIkarus::LoadControlConfig | Config for the Load-Control control routine |
CIkarus::LoadControlSubsidiaryFunction | Structure representing the subsidiary function for the load control method |
CIkarus::Materials::Material< MI > | Interface classf or materials |
►CIkarus::Materials::Material< Hyperelastic< DEV, NoVolumetricPart > > | |
CIkarus::Materials::Hyperelastic< DEV, VOL > | Implementation of a general Hyperelastic Material material model |
►CIkarus::Materials::Material< LinearElasticityT< ST > > | |
CIkarus::Materials::LinearElasticityT< ST > | Implementation of the Linear Elasticity material model.The energy is computed as |
►CIkarus::Materials::Material< NeoHookeT< ST > > | |
CIkarus::Materials::NeoHookeT< ST > | Implementation of the Neo-Hookean material model.The energy is computed as |
►CIkarus::Materials::Material< StVenantKirchhoffT< ScalarType > > | |
CIkarus::Materials::StVenantKirchhoffT< ScalarType > | |
►CIkarus::Materials::Material< StVenantKirchhoffT< ST > > | |
CIkarus::Materials::StVenantKirchhoffT< ST > | Implementation of the Saint Venant-Kirchhoff material model.The energy is computed as |
►CIkarus::Materials::Material< VanishingStrain< strainIndexPair, MI > > | |
CIkarus::Materials::VanishingStrain< strainIndexPair, MI > | VanishingStrain material model that enforces strain components to be zero |
►CIkarus::Materials::Material< VanishingStress< stressIndexPair, MI > > | |
CIkarus::Materials::VanishingStress< stressIndexPair, MI > | VanishingStress material model that enforces stress components to be zero |
CIkarus::MatrixAssembler< MA, FEC, DV, MT > | The MatrixAssembler provides an interface for an assembler that assembles matrix quantities |
►CIkarus::MatrixAssembler< DenseFlatAssembler< FEC, DV >, FEC, DV, Eigen::MatrixXd > | |
CIkarus::DenseFlatAssembler< FEC, DV > | DenseFlatAssembler assembles matrix quantities using a flat basis Indexing strategy. The matrix is stored in a dense matrix format. This format is exploited during the assembly process |
►CIkarus::MatrixAssembler< SparseFlatAssembler< FEC, DV >, FEC, DV, Eigen::SparseMatrix< double > > | |
CIkarus::SparseFlatAssembler< FEC, DV > | SparseFlatAssembler assembles matrix quantities using a flat basis Indexing strategy. The matrix is stored in a sparse matrix format. This format is exploited during the assembly process |
CIkarus::Materials::MatrixIndexPair | Represents a pair of stress or strain matrix indices (row and column) |
CIkarus::MatrixManipulator< Wrapper, Assembler > | Base class for a wrapper to a matrix assembler |
CIkarus::NeumannBoundaryLoadPre< GV > | A PreFE struct for Neumann boundary load skill |
CIkarus::NewtonRaphsonConfig< LS, UF > | Config for the Newton-Raphson solver |
CIkarus::NewtonRaphsonWithSubsidiaryFunctionConfig< LS, UF > | Settings for the Newton-Raphson solver with subsidiary function |
CIkarus::NewtonRaphsonWithSubsidiaryFunctionSettings | |
CIkarus::NonLinearElasticPre< MAT > | A PreFE struct for non-linear elastic elements |
CIkarus::NonlinearSolverFactory< NLSSetting > | A factory class for creating nonlinear solvers |
CIkarus::NonLinearSolverInformation | Information about the result of a non-linear solver |
CIkarus::NonlinearSolverState< D, CT > | State for nonlinear solvers |
CIkarus::AdaptiveStepSizing::NoOp | The NoOp strategy for adaptive step sizing |
CIkarus::NRSettings | |
CIkarus::Materials::OgdenT< ST_, n, tag > | Implementation of the Ogden material model |
CIkarus::PathFollowingConfig< PF_, ASS_ > | Config for the Path-Following control routine |
CIkarus::PathFollowingState< D > | State for path following control routine |
CIkarus::ResultEvaluators::PolarStress | Struct for calculating the 2d polar stress. The center of the coordinate system is to be passed to the evaluator |
CIkarus::PreFE< BH, useFlat, useEigenRef > | PreFE struct acts as a convenient wrapper for the FE class to access different type traits |
CIkarus::ResultEvaluators::PrincipalStress< dim > | Struct for calculating principal stresses |
►CRealMAT | |
CIkarus::Experimental::AutoDiffMAT< RealMAT, forceAutoDiffV, forceAutoDiffS > | Implementation of a AutoDiff-based material model |
CIkarus::traits::Rebind< Container, NewType > | Type trait to rebind the underlying type of containers |
CIkarus::traits::remove_pointer< T > | |
CIkarus::traits::ReplaceTypeAtPos< Tuple, Pos, NewType > | Helper to replace the type at a specific position in a tuple |
CIkarus::FEMixin< PreFE, Skills >::RequirementType< bool, typename > | |
CIkarus::FEMixin< PreFE, Skills >::RequirementType< false, T > | |
CIkarus::FEMixin< PreFE, Skills >::RequirementType< true, T > | |
CIkarus::ResultTypeBase< ResultTypes > | Base class for element definitions that provides common functionality for ResultTypes |
►CIkarus::ResultTypeBase< ResultTypes::cauchyAxialForce, ResultTypes::PK2AxialForce, ResultTypes::linearAxialForce > | |
CIkarus::Truss< PreFE, FE > | Truss class represents a truss finite element |
►CIkarus::ResultTypeBase< ResultTypes::linearStress, ResultTypes::linearStressFull > | |
CIkarus::LinearElastic< PreFE, FE, PRE > | LinearElastic class represents a linear elastic finite element |
►CIkarus::ResultTypeBase< ResultTypes::PK2Stress, ResultTypes::PK2StressFull > | |
CIkarus::NonLinearElastic< PreFE, FE, PRE > | NonLinearElastic class represents a non-linear elastic finite element |
►CIkarus::ResultTypeBase<> | |
CIkarus::KirchhoffLoveShell< PreFE, FE > | Kirchhoff-Love shell finite element class |
►CRT | |
CIkarus::ResultWrapper< RT, storedResultShape > | Container that is used for FE Results. It gives access to the stored value, but can also be used to access the result in Matrix and Vector form |
CIkarus::ScalarAssembler< SA, FEC, DV, ST > | The ScalarAssembler provides an interface for an assembler that assembles scalar quantities |
►CIkarus::ScalarAssembler< ScalarFlatAssembler< FEC, DV >, FEC, DV, double > | |
CIkarus::ScalarFlatAssembler< FEC, DV > | ScalarFlatAssembler assembles scalar quantities |
CIkarus::ScalarManipulator< Wrapper, Assembler > | Base class for a wrapper to a scalar assembler |
CScalarWrapper< T > | A wrapper class for scalar types to facilitate reference passing in Python bindings |
CIkarus::Skills< ARGS > | Struct representing a collection of skills |
►CSkills... | |
CIkarus::FEMixin< PreFE, Skills... > | |
►CIkarus::Skills< PreFE, PreFE::template FE< Skills... > > | |
CIkarus::FEMixin< PreFE, Skills > | CRTP mixin class for finite elements with additional skills |
CIkarus::utils::SolverDefault | Default functor for solving operations |
CEigen::SparseMatrixBase< Derived > | |
CIkarus::Python::SparseMatrixWrapper< T > | |
CIkarus::Stats | Information about the TrustRegion solver |
CIkarus::SubsidiaryArgs | Structure containing arguments for subsidiary functions |
CEigen::TCGInfo< Scalar > | |
CEigen::TCGInfo< double > | |
CEigen::TCGInfo< typename M::RealScalar > | |
►CMatrixAss::template Implementation | |
CIkarus::AssemblerManipulator< A, ScalarAss, VectorAss, MatrixAss > | |
►CScalarAss::template Implementation | |
CIkarus::AssemblerManipulator< A, ScalarAss > | |
CIkarus::AssemblerManipulator< A, ScalarAss, VectorAss > | |
CIkarus::AssemblerManipulator< A, ScalarAss, VectorAss, MatrixAss > | |
►CVectorAss::template Implementation | |
CIkarus::AssemblerManipulator< A, ScalarAss, VectorAss > | |
CIkarus::AssemblerManipulator< A, ScalarAss, VectorAss, MatrixAss > | |
►CMatrixAss::template Interface | |
CIkarus::AssemblerManipulator< A, ScalarAss, VectorAss, MatrixAss > | |
►CScalarAss::template Interface | |
CIkarus::AssemblerManipulator< A, ScalarAss > | |
CIkarus::AssemblerManipulator< A, ScalarAss, VectorAss > | |
CIkarus::AssemblerManipulator< A, ScalarAss, VectorAss, MatrixAss > | |
►CVectorAss::template Interface | |
CIkarus::AssemblerManipulator< A, ScalarAss, VectorAss > | |
CIkarus::AssemblerManipulator< A, ScalarAss, VectorAss, MatrixAss > | |
CIkarus::Traction< PreFE, FE > | Traction class represents distributed traction load that can be applied |
CEigen::internal::traits< TruncatedConjugateGradient< MatrixType_, UpLo, Preconditioner_ > > | |
CIkarus::ResultEvaluators::Triaxiality | Struct for calculating stress triaxiality |
CIkarus::TRSettings | |
►Cstd::true_type | |
CIkarus::Vtk::IsStructured< Dune::YaspGrid< dim, Coordinates > > | Specialization of IsStructured for YASPGrids, inherits from true_type |
CIkarus::traits::isSpecialization< U, U< T... > > | Type trait to check if a class is a specialization of a template |
CIkarus::traits::isSpecializationNonTypeAndTypes< Type, Type< T, N... > > | Type trait to check if a class is a specialization of a template with a non-type parameter and types |
CIkarus::traits::isSpecializationNonTypeNonTypeAndTypes< Type, Type< T, R, N... > > | Type trait to check if a class is a specialization of a template with two non-type parameter and types |
CIkarus::traits::isSpecializationNonTypes< Type, Type< N... > > | Type trait to check if a class is a specialization of a template with non-type parameters |
CIkarus::traits::isSpecializationTypeNonTypeAndType< Type, Type< T, M, N > > | Type trait to check if a class is a specialization of a template with types and two non-type parameters |
CIkarus::traits::is_tuple< std::tuple< T... > > | Type trait to check if a type is an instantiation of std::tuple |
CIkarus::TrussPre | A PreFE struct for truss elements |
CIkarus::TrustRegionConfig< preConditioner, UF > | |
CTrustRegionSettings | Configuration settings for the TrustRegion solver |
►Cstd::tuple | |
CIkarus::AffordanceCollection< Affordances > | Struct representing a collection of affordances |
CIkarus::traits::TupleToFunctionType< R, Tuple > | Helper to convert a tuple to a function type |
CIkarus::utils::UpdateDefault | Default functor for updating operations |
CIkarus::VectorAssembler< VA, FEC, DV, VT > | The VectorAssembler provides an interface for an assembler that assembles vector quantities |
►CIkarus::VectorAssembler< VectorFlatAssembler< FEC, DV >, FEC, DV, Eigen::VectorXd > | |
CIkarus::VectorFlatAssembler< FEC, DV > | VectorFlatAssembler assembles vector quantities using a flat basis Indexing strategy |
CIkarus::VectorManipulator< Wrapper, Assembler > | Base class for a wrapper to a vector assembler |
CIkarus::Materials::VF0 | Default volumetric function |
CIkarus::Materials::VF1 | Volumetric function No. 1 found in [7] Tab. 4 |
CIkarus::Materials::VF10 | Volumetric function No. 10 found in [7] Tab. 4 |
CIkarus::Materials::VF11 | Volumetric function No. 11 found in [7] Tab. 4 |
CIkarus::Materials::VF2 | Volumetric function No. 2 found in [7] Tab. 4 |
CIkarus::Materials::VF3 | Volumetric function No. 3 found in [7] Tab. 4 |
CIkarus::Materials::VF4 | Volumetric function No. 4 found in [7] Tab. 4 |
CIkarus::Materials::VF5 | Volumetric function No. 5 found in [7] Tab. 4 |
CIkarus::Materials::VF6 | Volumetric function No. 6 found in [7] Tab. 4 |
CIkarus::Materials::VF7 | Volumetric function No. 7 found in [7] Tab. 4 |
CIkarus::Materials::VF8 | Volumetric function No. 8 found in [7] Tab. 4 |
CIkarus::Materials::VF9 | Volumetric function No. 9 found in [7] Tab. 4 |
CIkarus::VolumeLoad< PreFE, FE > | VolumeLoad class represents distributed volume load that can be applied |
CIkarus::VolumeLoadPre< wd > | A PreFE struct for volume load skill |
CIkarus::Materials::Volumetric< VF > | Interface for the volumetric part of a hyperelastic material. Has to be parametrized with a volumetric function |
CIkarus::ResultEvaluators::VonMises | Struct for calculating von Mises stress |
►CDune::VTKFunction | |
CIkarus::ResultFunction< AS, RT, UserFunction > | Wrapper to evaluate results for a vtkwriter |
CIkarus::YoungsModulusAndBulkModulus | Structure representing Young's modulus and Lame's first parameter |
CIkarus::YoungsModulusAndLamesFirstParameter | Structure representing bulk modulus and Lame's first parameter |
CIkarus::YoungsModulusAndPoissonsRatio | See https://en.wikipedia.org/wiki/Lam%C3%A9_parameters Structure representing Young's modulus and shear modulus |
CIkarus::YoungsModulusAndShearModulus | Structure representing Young's modulus and bulk modulus |
►CIkarus::A | |
CIkarus::AssemblerManipulator< A, ScalarAss > | |
CIkarus::AssemblerManipulator< A, ScalarAss, VectorAss > | |
CIkarus::AssemblerManipulator< A, ScalarAss, VectorAss, MatrixAss > | |