►CAbstractNumericalFlux< Mesh, SolverType > | AbstractNumericalFlux Gives a common interface for hyperbolic's flux function |
CGodunovNumericalFlux< Mesh, SolverType > | GodunovNumericalFlux Gives an implementation for Godunov solver for hyperbolic's flux function |
CAdd_KN_< R > | |
CAdd_Mulc_KN_< R > | |
Cadm_shapes< GeoShape > | |
CADRAssembler< mesh_type, matrix_type, vector_type > | ADRAssembler - This class add into given matrices terms corresponding to the space discretization of the ADR problem |
CADRAssembler< LifeV::RegionMesh, LifeV::MatrixEpetraStructured, LifeV::VectorEpetra > | |
CADRAssemblerIP< mesh_type, matrix_type, vector_type > | ADRAssemblerIP - This class is used to add IP stabilization to an Advection-Diffusion-Reaction problem |
CALE | 2D/3D robinMembrane Simulation class |
CALESolver | |
CAnalyticalSol | |
CAnalyticalSol_2d | |
CAnalyticalSolution | |
CaortaVelIn | |
►CAssemblyPolicy | |
CTimeIterationPolicyLinear< mesh_Type, AssemblyPolicy, SolverPolicy > | |
CTimeIterationPolicyNonlinear< mesh_Type, AssemblyPolicy, SolverPolicy > | |
CTimeIterationPolicyNonlinearIncremental< mesh_Type, AssemblyPolicy, SolverPolicy > | |
CAssemblyPolicyGeneralizedStokes< mesh_Type > | |
►CAssemblyPolicyStokes< mesh_Type > | |
CAssemblyPolicyNavierStokesNewton< mesh_Type > | |
CAssemblyPolicyNavierStokesPicard< mesh_Type > | |
CAssemblyPolicyNavierStokesSemiImplicit< mesh_Type > | |
CInitPolicyProjection< mesh_Type, SolverPolicy > | |
CAssert | |
CAssertContext | Details about a failed assertion |
CassertInitializer | |
CBareEdge | The Edge basis class |
CBareEntitySelector< Shape > | BareEntitySelector class - Select the proper bare entity type (bareEdge or bareFace) based on the number of the entity points |
CBareEntitySelector< Line > | |
CBareEntitySelector< Point > | |
CBareEntitySelector< Quad > | |
CBareEntitySelector< Triangle > | |
CBareFace | The base Face class |
CBareMesh< GeoShapeType > | A struct for a bare mesh |
CBareVertex | The Vertex basis class |
Cbc_adaptor | |
Cbc_adaptorBrain | |
Cbc_adaptorFace | |
CBCBase | BCBase - Base class which holds the boundary condition information |
CBCDataInterpolator::BCDataInterpolator_point | |
►CBCFunctionBase | BCFunctionBase - class that holds the function used for prescribing boundary conditions |
CBCDataInterpolator | BCDataInterpolator - Class for interpolating boundary functions from scattered data |
CBCFunctionDirectional | BCFunctionUDepBase - class that holds the function used for prescribing boundary conditions |
CBCFunctionRobin | BCFunctionRobin - class that holds the function used for prescribing Robin boundary conditions |
►CBCFunctionUDepBase | BCFunctionUDepBase - class that holds the function used for prescribing boundary conditions |
CBCFunctionUDepRobin | BCFunctionUDepRobin - class that holds the function used for prescribing Robin boundary conditions |
CBCHandler | BCHandler - class for handling boundary conditions |
►CBCIdentifierBase | BCIdentifierBase - Base class holding DOF identifiers for implementing BC |
CBCIdentifierEssential | BCIdentifierEssential - BCIdentifier for implementing Essential Boundary Conditions |
CBCIdentifierNatural | BCIdentifierNatural - Idenifier for Natural and Robin Boundary Condiions |
CBCIdentifierComparison | BCIdentifierComp - Functor for ordering operations (required in set STL container) |
►CBCInterface< BcHandler, PhysicalSolverType > | BCInterface - LifeV interface to load boundary conditions completely from a GetPot file |
CBCInterface0D< BcHandler, PhysicalSolverType > | BCInterface0D - LifeV interface to load boundary conditions for 0D problems completely from a GetPot file |
CBCInterface1D< BcHandler, PhysicalSolverType > | BCInterface1D - LifeV interface to load boundary conditions for 1D problems completely from a GetPot file |
CBCInterface3D< BcHandler, PhysicalSolverType > | BCInterface3D - LifeV interface to load boundary conditions for 3D problems completely from a GetPot file |
►CBCInterfaceData | BCInterfaceData - The BCInterface data container |
CBCInterfaceData0D | BCInterfaceData0D - The BCInterface1D data container |
CBCInterfaceData1D | BCInterfaceData1D - The BCInterface1D data container |
CBCInterfaceData3D | BCInterfaceData3D - The BCInterface3D data container |
CBCInterfaceFactory< BcHandlerType, PhysicalSolverType > | BCInterfaceFactory - Factory to create BCInterface functions |
►CBCInterfaceFunction< BcHandlerType, PhysicalSolverType > | BCInterfaceFunction - Base class for BCInterface boundary functions |
►CBCInterfaceFunctionParser< BcHandlerType, PhysicalSolverType > | BCInterfaceFunctionParser - LifeV boundary condition function wrapper for BCInterface |
►CBCInterfaceFunctionParserFile< BcHandlerType, PhysicalSolverType > | BCInterfaceFunctionParserFile - LifeV boundary condition function file wrapper for BCInterface |
CBCInterfaceFunctionParserFileSolver< BcHandlerType, PhysicalSolverType > | BCInterfaceFunctionParserFileSolver - LifeV boundary condition function file wrapper for BCInterface |
►CBCInterfaceFunctionParserSolver< BcHandlerType, PhysicalSolverType > | BCInterfaceFunctionParserSolver - LifeV boundary condition function file wrapper for BCInterface |
CBCInterfaceFunctionParserFileSolver< BcHandlerType, PhysicalSolverType > | BCInterfaceFunctionParserFileSolver - LifeV boundary condition function file wrapper for BCInterface |
CBCInterfaceFunctionUserDefined< BcHandlerType, PhysicalSolverType > | BCInterfaceFunctionUserDefined - User defined functions for BCInterface |
CBCInterfaceFunctionSolverDefined< BcHandlerType, PhysicalSolverType > | BCInterfaceFunctionSolverDefined - Empty class for solver defined specializations |
CBCInterfaceFunctionSolverDefined< BCHandler, FSIOperator > | BCInterfaceFunctionSolverDefined - Template specialization of BCInterfaceFunctionSolverDefined for 3D FSI problems |
CBCInterfaceFunctionSolverDefined< BCHandler, StructuralOperator< RegionMesh< LinearTetra > > > | BCInterfaceFunctionSolverDefined - Template specialization of BCInterfaceFunctionSolverDefined for Solid 3D problems |
CBCInterfaceFunctionSolverDefined< OneDFSIBCHandler, OneDFSISolver > | BCInterfaceFunctionSolverDefined - Template specialization of BCInterfaceFunctionSolverDefined for 1D problems |
CBCManageNormal< MatrixType > | BCManageNormal - class for handling normal essential boundary conditions |
►CBCVectorBase | BCVectorBase - class that holds the FE vectors used for prescribing boundary conditions |
CBCVector | BCVector - class that holds the FE vectors used for prescribing boundary conditions |
CBCVectorInterface | BCVectorInterface - class that holds the FE vectors used for prescribing boundary conditions on Interfaces |
CBDFSecondOrderDerivative | |
CBlockEpetra_Map | This class handles block access to parallel monolithic Vectors with an underling block structure |
CbooleanSelector | |
CbuildVector | |
CCircleInterrogator< MeshEntityType, ComparisonPolicyType > | |
CcmpBareItem< T > | General functor for lexicographic comparison |
CcmpBareItem< BareEdge > | Specialized functor for Edges |
CcmpBareItem< BareFace > | Specialized functor for Faces |
CcmpBareItem< BareVertex > | Specialized functor for Vertices |
CCompareAccordingToLocalId< MeshEntity, Policy > | Compare according to local ID |
CCompareAccordingToMarker< MeshEntity, Policy > | Compare according to Marker ID |
CComputeFineScalePressure< MeshType, TestSpaceType, ExpressionType, QRAdapterType > | The class to actually perform the loop over the elements to compute the fine scale velocity at the center of each element |
CComputeFineScaleVelocity< MeshType, TestSpaceType, ExpressionType, QRAdapterType > | The class to actually perform the loop over the elements to compute the fine scale velocity at the center of each element |
CConstant | Const - Base class for One Dimensional BC Functions |
Cconvert_spec< dim > | |
Cconvert_spec< 1 > | |
Cconvert_spec< 2 > | |
Cconverter< S, MC > | |
►CCos_min_Sin | Cos_min_Sin - A superimposition of a sinusoidal and a cosinusoidal waves, whose amplitude is damped by exponential terms |
CAnalytical_Solution | Analytical_Solution - A particular case of Cos_min_Sin |
►CCurrentFE | CurrentFE - A primordial class for the assembly of the local matrices/vectors retaining the values on the real cells |
CCurrentFEManifold | A class for a finite element on a manifold |
CCylinder | 2D/3D Cylinder Simulation class |
Cdarcy_linear | Includes |
Cdarcy_nonlinear | Includes |
CDarcyData< MeshType > | Contain the basic data for the Darcy solver |
►CDarcySolverLinear< MeshType > | Implements a mixed-hybrid FE Darcy solver |
►CDarcySolverNonLinear< MeshType > | Implements a non-linear Darcy solver |
CDarcySolverTransientNonLinear< MeshType > | Implements a non-linear transient mixed-hybrid FE Darcy solver |
►CDarcySolverTransient< MeshType > | Implements a mixed-hybrid FE Darcy solver for transient problems |
CDarcySolverTransientNonLinear< MeshType > | Implements a non-linear transient mixed-hybrid FE Darcy solver |
CDataADR | |
CDataBidomain | |
CDataIonic | |
CDataLevelSet | DataLevelSet - Container for the data for the level set solver |
CDataMonodomain | |
CDebugStream | |
CDensityFct | |
CDimSelector< Dim > | |
CDimSelector< 2 > | |
CDimSelector< 3 > | |
CDisplayer | Displayer - This class is used to display messages in parallel simulations |
CDOF | |
CDOFGatherer< MeshType > | Class that produces a list of dof GID from a list of element LIDs |
►CDOFInterface | |
CDOFInterface3Dto2D | |
CDOFInterface3Dto3D | |
►CDOFLocalPattern | DOFLocalPattern - A class to store the "couplings" between the basis functions |
►CReferenceFE | The class for a reference Lagrangian finite element |
CReferenceFEHdiv | ReferenceFEHdiv - Short description of the class |
CReferenceFEHybrid | |
CReferenceFEScalar | RefFEScalar - Short description of the class |
CDummy | |
►CedgeMarker_Type | |
CMeshElementMarked< 1, 1, GeoShape, MC > | Specialization for 1D entities (edges) in 1D Geometry |
CMeshElementMarked< 1, 3, GeoShape, MC > | Specialization for 1D entities (edges) in 3D geometry |
CElectroETABidomainSolver< Mesh, IonicModel > | BidomainSolver - Class featuring the usual solver for bidomain equations |
CElectroETAMonodomainSolver< Mesh, IonicModel > | MonodomainSolver - Class featuring the solver for monodomain equations |
►CElectroIonicModel | |
CIonicAlievPanfilov | IonicModel - This class implements an ionic model |
CIonicFitzHughNagumo | |
CIonicFox | IonicModel - This class implements an ionic model |
CIonicGoldbeter | |
CIonicHodgkinHuxley | IonicModel - This class implements the Hodgkin-Huxley model |
CIonicLuoRudyI | IonicModel - This class implements an ionic model |
CIonicMinimalModel | IonicModel - This class implements an ionic model |
CIonicMitchellSchaeffer | IonicModel - This class implements an ionic model |
CIonicNoblePurkinje | IonicModel - This class implements an ionic model |
CIonicTenTusscher06 | IonicModel - This class implements an ionic model |
►CElectroStimulus | |
CStimulusPacingProtocol | |
CStimulusPMJ | |
CStimulusSingleSource | |
CEmptyPhysicalSolver< vector_Type > | |
CEnquireBEdge< MeshType > | |
CEnquireBFace< MeshType > | Functor to check if a Face is on the boundary |
CEnquireBPoint< MeshType > | |
CEnsightToHdf5 | |
CEntityFlagInterrogator< MeshEntity, ComparisonPolicy > | A simple predicate to test the boolean flag on a mesh entity |
CEntityMarkerIDInterrogator< MeshEntity, ComparisonPolicy > | A simple predicate to test the marker ID flag |
CMeshPartBuilder< MeshType >::entityPID_Type | |
CMeshPartitioner< MeshType >::EntityPIDList | Store ownership for each entity, subdivided by entity type |
►CEpetra_MultiVector | |
CBlockEpetra_MultiVector | A derived class from Epetra_MultiVector specialized to handle parallel block structured Vectors |
►CEpetra_Operator | |
CComposedOperator< OperatorType > | ComposedOperator - |
CFSIExactJacobian::Epetra_ExactJacobian | Epetra_ExactJacobian This class implements an Epetra_Operator to be passed to AztecOO |
►CLinearOperator | Abstract class which defines the interface of a Linear Operator |
CConfinedOperator | Class which wrap an operator to apply it only on a restriction |
►CSolverOperator | Abstract class which defines the interface of an Invertible Linear Operator |
CAztecooOperator | Abstract class which defines the interface of an Invertible Linear Operator |
CBelosOperator | Class which defines the interface of an Invertible Linear Operator through belos |
CSolverOperatorAlgo | Abstract class which defines the interface of an Invertible Linear Operator |
►CLinearOperatorAlgebra | Abstract class which defines the interface of a Linear Operator |
CApproximatedInvertibleRowMatrix | Provide the ApplyInverse method for a Epetra_CrsMatrix object |
CBlockJacobiPreconditioner | |
CBlockOperator | A abstract class for handling n-by-m block operators This class inherits from LifeV::LinearOperatorAlgebra |
CCompositeOperator | |
CFSIApplyOperator | A abstract class for handling n-by-m block operators This class inherits from LifeV::LinearOperator |
CFSIApplyOperatorNonConforming | A class which implements the application of the FSI Jacobian matrix to a given vector when nonconforming meshes are used. This class inherits from LifeV::LinearOperator |
CIdentityOperator | Identity operator x = I*x |
►CInvertibleOperator | Abstract class which defines the interface of an Invertible Linear Operator Algebra |
CAztecooOperatorAlgebra | InvertibleOperator interface to AztecOO in Trilinos. AztecooOperator will use the matrix-free Krylov methods in Trilinos, therefore both the operator and the preconditioner must be given in the form of LinearOperator |
CBelosOperatorAlgebra | InvertibleOperator interface to Belos in Trilinos. BelosOperator requires the operator to be solved and the preconditioner in the form of LinearOperator |
CLumpedOperator | A class for Mass Lumping The lumped mass matrix is such that (1) The total mass is conserved (2) {M}_{i,i} is proportional to M_{i,i} |
CNavierStokesOperator | A abstract class for handling n-by-m block operators This class inherits from LifeV::LinearOperator |
►CNavierStokesPreconditionerOperator | |
CaSIMPLEOperator | |
CNullOperator | Null operator 0 = Z*x |
►CRowMatrixPreconditioner | Abstract class to construct preconditioners from a matrix in Epetra_CsrFormat |
CIfpackPreconditioner | Interface to the Ifpack preconditioners in Trilinos |
CMLPreconditioner | Interface to the ML preconditioners in Trilinos |
CTwoLevelPreconditioner | An operator that provides a two level approximation of the inverse of a Epetra_CsrMatrix object |
CTwoLevelOperator | It defines a two level methods to approximately apply the inverse of a fine level operator |
Cerror_msg | |
CETA_ADR1DTest | |
CETA_ADR2DTest | Simple ETA test to compare ETA to ADRAssembly in a 2D space |
CETA_Blocks2DTest | Simple ETA test to compute a block matrix associated to the Stokes problem |
CETA_InterpolateGradient2DTest | Simple ETA to check the evaluation of a gradient interpolation and the use of SmallMatrix costants in expressions |
CETA_VectorialADR2DTest | Simple ETA test to compare ETA to ADRAssembly in a 2D space with a 2D solution |
CETCurrentBDFE< spaceDim > | ETCurrentBDFE - Short description of the class |
CETCurrentFE< spaceDim, fieldDim > | |
CETCurrentFE< spaceDim, fieldDim > | |
CETCurrentFE< 3, 1 > | |
CETCurrentFE< 3, 3 > | |
CETCurrentFE< 3, SolutionSpaceType::field_dim > | |
CETCurrentFE< 3, SolutionSpaceType::S_fieldDim > | |
CETCurrentFE< 3, TestSpaceType::field_dim > | |
CETCurrentFE< 3, TestSpaceType::S_fieldDim > | |
CETCurrentFE< FESpaceType::space_dim, 1 > | |
CETCurrentFE< LSFESpaceType ::space_dim, 1 > | |
CETCurrentFE< MeshType::S_geoDimensions, 1 > | |
CETCurrentFE< SolutionSpaceType::space_dim, SolutionSpaceType::field_dim > | |
CETCurrentFE< spaceDim, 1 > | |
CETCurrentFE< SpaceDim, 1 > | |
CETCurrentFE< SpaceDim, FieldDim > | |
CETCurrentFE< TestSpaceType::space_dim, SolutionSpaceType::field_dim > | |
CETCurrentFE< TestSpaceType::space_dim, TestSpaceType::field_dim > | |
CETFESpace< MeshType, MapType, SpaceDim, FieldDim > | Class ETFESpace A light, templated version of the FESpace |
CETMatrixElemental | Class ETMatrixElemental A class for describing an elemental matrix |
CETRobinMembraneSolver | |
CETVectorElemental | Class ETVectorElemental A class for describing an elemental vector |
CEvaluateAtQuadraturePoint< MeshType, TestSpaceType, ExpressionType, QRAdapterType > | The class to actually perform the loop over the elements to compute the stresses at the center of each element |
CEvaluateNodalExpressionVectorElement< MeshType, SolutionSpaceType, ExpressionType, QRAdapterType > | The class to actually perform the loop over the elements to assemble a vector |
CEvaluateNodalExpressionVectorElementFaceID< MeshType, SolutionTestSpace, ExpressionType > | The class to actually perform the loop over the elements to assemble a vector |
CEvaluationAddition< EvaluationLType, EvaluationRType > | Evaluation for the addition of two other Evaluations |
CEvaluationArcTan< EvaluationBaseType > | Evaluation for the product of two other Evaluations |
CEvaluationCubicRoot< EvaluationBaseType > | Evaluation for the product of two other Evaluations |
CEvaluationDerivativeArcTan< EvaluationBaseType > | Evaluation for the product of two other Evaluations |
CEvaluationDeterminant< EvaluationType > | Evaluation for the transpose of another Evaluation |
CEvaluationDetJacobian< spaceDim > | EvaluationDetJacobian - Evaluation of the determinant of the Jacobian |
CEvaluationDivI< fieldDim, spaceDim > | |
CEvaluationDivI< 2, spaceDim > | Evaluation of the basis function divergence in the case of a 2D vectorial FE |
CEvaluationDivI< 3, spaceDim > | Evaluation of the basis function divergence in the case of a vectorial FE |
CEvaluationDivision< EvaluationLType, EvaluationRType > | Evaluation for the quotient of two other Evaluations |
CEvaluationDivJ< fieldDim, spaceDim > | |
CEvaluationDivJ< 2, spaceDim > | Evaluation of the basis function div(phi_j) in the case of a 2D vectorial FE |
CEvaluationDivJ< 3, spaceDim > | Evaluation of the basis function div(phi_j) in the case of a vectorial FE |
CEvaluationDot< EvaluationLType, EvaluationRType > | Evaluation for the dot product between two other Evaluations |
CEvaluationDphiI< fieldDim, spaceDim > | Evaluation of the basis function dphi_i in the case of a vectorial FE |
CEvaluationDphiI< 1, spaceDim > | Evaluation of the basis function dphi_i in the case of a scalar FE |
CEvaluationDphiJ< fieldDim, spaceDim > | Evaluation of the basis function dphi_j in the case of a vectorial FE |
CEvaluationDphiJ< 1, spaceDim > | Evaluation of the basis function dphi_j in the case of a scalar FE |
CEvaluationEmult< EvaluationLType, EvaluationRType > | Evaluation for the element-wise multiplication between two other Evaluations |
CEvaluationExponential< EvaluationBaseType > | Evaluation for the product of two other Evaluations |
CEvaluationExtract1< EvaluationType > | Evaluation for the extraction of a row resp. component from a matrix resp. a vector |
CEvaluationExtract2< EvaluationType > | Evaluation for the extraction of a component from a matrix |
CEvaluationExtractScalar< VectorType > | |
CEvaluationFunctor1< FunctorType, ArgumentEvaluationType > | Evaluation for a generic functor with 1 argument |
CEvaluationFunctor2< FunctorType, Argument1EvaluationType, Argument2EvaluationType > | Evaluation for a generic functor with 2 arguments |
CEvaluationHK< spaceDim > | EvaluationHK - Evaluation of the diameter of the cell |
CEvaluationIfCrossed< MeshType, MapType, SpaceDim > | Evaluation for the interpolation of a FE function |
CEvaluationInterpolateGradient< MeshType, MapType, SpaceDim, FieldDim > | Evaluation for the interpolation of a FE function |
CEvaluationInterpolateGradient< MeshType, MapType, 3, 3 > | Evaluation for the interpolation of the gradient of a FE function |
CEvaluationInterpolateGradient< MeshType, MapType, SpaceDim, 1 > | Evaluation for the interpolation of the gradient of a FE function |
CEvaluationInterpolateLaplacian< MeshType, MapType, SpaceDim, FieldDim > | Evaluation for the interpolation of a FE function |
CEvaluationInterpolateLaplacian< MeshType, MapType, SpaceDim, 1 > | Evaluation for the interpolation of the laplacian of a FE function |
CEvaluationInterpolateValue< MeshType, MapType, SpaceDim, FieldDim > | Evaluation for the interpolation of a FE function |
CEvaluationInterpolateValue< MeshType, MapType, SpaceDim, 1 > | Evaluation for the interpolation of a FE function |
CEvaluationInverse< EvaluationType > | Evaluation for the transpose of another Evaluation |
CEvaluationIsochoricChangeOfVariable< EvaluationBaseType > | |
CEvaluationLaplacianI< fieldDim, spaceDim > | Evaluation of the laplacian of the basis function phi_i in the case of a vectorial FE |
CEvaluationLaplacianI< 1, spaceDim > | Evaluation of the basis function dphi_i in the case of a scalar FE |
CEvaluationLaplacianJ< fieldDim, spaceDim > | Evaluation of the laplacian of the basis function phi_i in the case of a vectorial FE |
CEvaluationLaplacianJ< 1, spaceDim > | Evaluation of the basis function dphi_i in the case of a scalar FE |
CEvaluationLogarithm< EvaluationBaseType > | Evaluation for the product of two other Evaluations |
CEvaluationMatrix< MatrixDim1, MatrixDim2 > | Evaluation for a matricial constant |
CEvaluationMeas< spaceDim > | EvaluationMeas - Evaluation of the measure of the cell |
CEvaluationMeasBDCurrentFE< spaceDim > | EvaluationMeasBDCurrentFE - Evaluation of the measure of the cell |
CEvaluationMetricTensor< spaceDim > | EvaluationHK - Evaluation of the metric tensor of the cell |
CEvaluationMetricVector< spaceDim > | EvaluationHK - Evaluation of the metric tensor of the cell |
CEvaluationMinusTransposed< EvaluationType > | Evaluation for the transpose of another Evaluation |
CEvaluationNormal< spaceDim > | EvaluationNormal - Evaluation of the normal |
CEvaluationNormalize< EvaluationType > | Evaluation for the transpose of another Evaluation |
CEvaluationOuterProduct< EvaluationLType, EvaluationRType > | Evaluation for the element-wise multiplication between two other Evaluations |
CEvaluationPatchArea< MeshType, MapType, SpaceDim, FieldDim > | Evaluation for the interpolation of a FE function |
CEvaluationPhiI< testDim > | Evaluation of the basis function phi_i in the case of a vectorial FE |
CEvaluationPhiI< 1 > | Evaluation of the basis function phi_i in the case of a scalar FE |
CEvaluationPhiJ< solutionDim > | Evaluation of the basis function phi_j in the case of a scalar FE |
CEvaluationPhiJ< 1 > | Evaluation of the basis function phi_j in the case of a scalar FE |
CEvaluationPosition< spaceDim > | EvaluationPosition - Evaluation of the position |
CEvaluationPower< EvaluationBaseType > | Evaluation for the product of two other Evaluations |
CEvaluationProduct< EvaluationLType, EvaluationRType > | Evaluation for the product of two other Evaluations |
CEvaluationReturnAtQuadraturePoints< MeshType, MapType, SpaceDim, FieldDim > | Evaluation for the interpolation of a FE function |
CEvaluationReturnAtQuadraturePoints< MeshType, MapType, SpaceDim, 1 > | Evaluation for the interpolation of a FE function |
CEvaluationScalar | Evaluation for a scalar constant |
CEvaluationScalarToVector< EvaluationType, FieldDim > | Evaluation for the transpose of another Evaluation |
CEvaluationSquareRoot< EvaluationBaseType > | Evaluation for the product of two other Evaluations |
CEvaluationSubstraction< EvaluationLType, EvaluationRType > | Evaluation for the difference of two other Evaluations |
CEvaluationSymmetricTensor< EvaluationType > | Evaluation for the transpose of another Evaluation |
CEvaluationTrace< EvaluationType > | Evaluation for the transpose of another Evaluation |
CEvaluationTranspose< EvaluationType > | Evaluation for the transpose of another Evaluation |
CEvaluationVector< VectorDim > | Evaluation for a vectorial constant |
CEvaluationVectorFromNonConstantMatrix< EvaluationType, SpaceDim, FieldDim > | Evaluation for a vectorial constant |
CEvaluationVectorFromNonConstantScalar< EvaluationType, FieldDim > | Evaluation for the transpose of another Evaluation |
CExactSol | |
CExampleClass | ExampleClass - Short description of the class |
►Cexception | |
CFactoryDefaultError< AbstractProduct >::Exception | |
►CExporter< MeshType > | Exporter - Pure virtual class that describes a generic exporter |
CExporterEmpty< MeshType > | |
CExporterEnsight< MeshType > | ExporterEnsight data exporter |
►CExporterHDF5< MeshType > | Hdf5 data exporter, implementation of Exporter |
CExporterHDF5Mesh3D< MeshType > | Class derived from ExporterHDF5 to provide I/O for the mesh partitions (RegionMesh only) |
CExporterVTK< MeshType > | ExporterVTK data exporter |
CExporterData< MeshType > | ExporterData - Holds the data structure of the array to import/export |
CExporterPolicyHDF5< mesh_Type > | |
CExporterPolicyNoExporter | |
CExpressionBase< DerivedType > | Class ExpressionBase Base class (static polymorphism, CRTP sense) for all the expressions used in assembly procedures |
►CExpressionBase< ExpressionAddition< LExpressionType, RExpressionType > > | |
CExpressionAddition< LExpressionType, RExpressionType > | Class ExpressionAddition Class for representing an addition between two expressions |
►CExpressionBase< ExpressionArcTan< BaseExpressionType > > | |
CExpressionArcTan< BaseExpressionType > | Class ExpressionPower Class for representing a product between two expressions |
►CExpressionBase< ExpressionCubicRoot< BaseExpressionType > > | |
CExpressionCubicRoot< BaseExpressionType > | Class ExpressionCubicRoot Class for representing a product between two expressions |
►CExpressionBase< ExpressionDerivativeArcTan< BaseExpressionType > > | |
CExpressionDerivativeArcTan< BaseExpressionType > | Class ExpressionPower Class for representing a product between two expressions |
►CExpressionBase< ExpressionDeterminant< ExpressionType > > | |
CExpressionDeterminant< ExpressionType > | Class ExpressionEmult Class for representing the transpose operation of an expression |
►CExpressionBase< ExpressionDetJacobian > | |
CExpressionDetJacobian | ExpressionDetJacobian - Expression for the diameter of the element |
►CExpressionBase< ExpressionDivI > | |
CExpressionDivI | Class ExpressionDivI Class representing the divergence of the test function in an expression |
►CExpressionBase< ExpressionDivision< LExpressionType, RExpressionType > > | |
CExpressionDivision< LExpressionType, RExpressionType > | Class ExpressionDivision Class for representing a quotient between two expressions |
►CExpressionBase< ExpressionDivJ > | |
CExpressionDivJ | Class ExpressionDivJ Class representing the divergence of the solution in an expression |
►CExpressionBase< ExpressionDot< LExpressionType, RExpressionType > > | |
CExpressionDot< LExpressionType, RExpressionType > | Class ExpressionDot Class for representing a dot product between two expressions |
►CExpressionBase< ExpressionDphiI > | |
CExpressionDphiI | Class ExpressionPhiI Class representing the gradient of the test function in an expression |
►CExpressionBase< ExpressionDphiJ > | |
CExpressionDphiJ | Class ExpressionDphiJ Class representing the gradient of the solution in an expression |
►CExpressionBase< ExpressionEmult< LExpressionType, RExpressionType > > | |
CExpressionEmult< LExpressionType, RExpressionType > | Class ExpressionEmult Class for representing a element-wise multiplication between two expressions |
►CExpressionBase< ExpressionExponential< BaseExpressionType > > | |
CExpressionExponential< BaseExpressionType > | Class ExpressionLogarithm Class for representing a product between two expressions |
►CExpressionBase< ExpressionExtract1< ExpressionType > > | |
CExpressionExtract1< ExpressionType > | Class ExpressionExtract1 Class for representing the extraction of a component or vector by specifying one index |
►CExpressionBase< ExpressionExtract2< ExpressionType > > | |
CExpressionExtract2< ExpressionType > | Class ExpressionExtract2 Class for representing the extraction of a component from a matrix (2 indexes specified) |
►CExpressionBase< ExpressionExtractScalar< VectorType > > | |
CExpressionExtractScalar< VectorType > | Class ExpressionScalar Class representing a scalar constant in an expression |
►CExpressionBase< ExpressionFunctor1< FunctorType, ArgumentType > > | |
CExpressionFunctor1< FunctorType, ArgumentType > | Class ExpressionFunctor1 Class representing a functor with 1 expression as arguement |
►CExpressionBase< ExpressionFunctor2< FunctorType, ArgumentType1, ArgumentType2 > > | |
CExpressionFunctor2< FunctorType, ArgumentType1, ArgumentType2 > | 2 ARGUMENTS |
►CExpressionBase< ExpressionHK > | |
CExpressionHK | ExpressionHK - Expression for the diameter of the element |
►CExpressionBase< ExpressionIfCrossed< MeshType, MapType, SpaceDim > > | |
CExpressionIfCrossed< MeshType, MapType, SpaceDim > | Class ExpressionInterpolateValue Class representing an interpolation in an expression |
►CExpressionBase< ExpressionInterpolateGradient< MeshType, MapType, SpaceDim, FieldDim > > | |
CExpressionInterpolateGradient< MeshType, MapType, SpaceDim, FieldDim > | Class ExpressionInterpolateGradient Class representing an interpolation in an expression |
►CExpressionBase< ExpressionInterpolateLaplacian< MeshType, MapType, SpaceDim, FieldDim > > | |
CExpressionInterpolateLaplacian< MeshType, MapType, SpaceDim, FieldDim > | Class ExpressionInterpolateLaplacian Class representing an interpolation in an expression |
►CExpressionBase< ExpressionInterpolateValue< MeshType, MapType, SpaceDim, FieldDim > > | |
CExpressionInterpolateValue< MeshType, MapType, SpaceDim, FieldDim > | Class ExpressionInterpolateValue Class representing an interpolation in an expression |
►CExpressionBase< ExpressionInverse< ExpressionType > > | |
CExpressionInverse< ExpressionType > | Class ExpressionEmult Class for representing the transpose operation of an expression |
►CExpressionBase< ExpressionIsochoricChangeOfVariable< BaseExpressionType > > | |
CExpressionIsochoricChangeOfVariable< BaseExpressionType > | |
►CExpressionBase< ExpressionLaplacianI > | |
CExpressionLaplacianI | Class ExpressionLaplacianI Class representing the laplacian of the test function in an expression |
►CExpressionBase< ExpressionLaplacianJ > | |
CExpressionLaplacianJ | Class ExpressionLaplacianJ Class representing the laplacian of the trial function in an expression |
►CExpressionBase< ExpressionLogarithm< BaseExpressionType > > | |
CExpressionLogarithm< BaseExpressionType > | Class ExpressionLogarithm Class for representing a product between two expressions |
►CExpressionBase< ExpressionMatrix< MatrixDim1, MatrixDim2 > > | |
CExpressionMatrix< MatrixDim1, MatrixDim2 > | Class ExpressionVector Class representing a constant matrix value in an expression |
►CExpressionBase< ExpressionMeas > | |
CExpressionMeas | ExpressionMeas - Expression for the measure of the element |
►CExpressionBase< ExpressionMeasBDCurrentFE > | |
CExpressionMeasBDCurrentFE | ExpressionMeasBDCurrentFE - Expression for the measure of the element |
►CExpressionBase< ExpressionMetricTensor > | |
CExpressionMetricTensor | |
►CExpressionBase< ExpressionMetricVector > | |
CExpressionMetricVector | |
►CExpressionBase< ExpressionMinusTransposed< ExpressionType > > | |
CExpressionMinusTransposed< ExpressionType > | Class ExpressionEmult Class for representing the transpose operation of an expression |
►CExpressionBase< ExpressionNormal > | |
CExpressionNormal | ExpressionNormal - Expression for the normal |
►CExpressionBase< ExpressionNormalize< ExpressionType > > | |
CExpressionNormalize< ExpressionType > | Class ExpressionEmult Class for representing the transpose operation of an expression |
►CExpressionBase< ExpressionOuterProduct< LExpressionType, RExpressionType > > | |
CExpressionOuterProduct< LExpressionType, RExpressionType > | Class ExpressionOuterProduct Class for representing a vector product multiplication between two vector expressions |
►CExpressionBase< ExpressionPatchArea< MeshType, MapType, SpaceDim, FieldDim > > | |
CExpressionPatchArea< MeshType, MapType, SpaceDim, FieldDim > | Class ExpressionInterpolateValue Class representing an interpolation in an expression |
►CExpressionBase< ExpressionPhiI > | |
CExpressionPhiI | Class ExpressionPhiI Class representing the value of the test function in an expression |
►CExpressionBase< ExpressionPhiJ > | |
CExpressionPhiJ | Class ExpressionPhiJ Class representing the value of the solution in an expression |
►CExpressionBase< ExpressionPosition > | |
CExpressionPosition | ExpressionPosition - Expression for the position (=quadrature node) |
►CExpressionBase< ExpressionPower< BaseExpressionType > > | |
CExpressionPower< BaseExpressionType > | Class ExpressionPower Class for representing a product between two expressions |
►CExpressionBase< ExpressionProduct< LExpressionType, RExpressionType > > | |
CExpressionProduct< LExpressionType, RExpressionType > | Class ExpressionProduct Class for representing a product between two expressions |
►CExpressionBase< ExpressionReturnAtQuadraturePoints< MeshType, MapType, SpaceDim, FieldDim > > | |
CExpressionReturnAtQuadraturePoints< MeshType, MapType, SpaceDim, FieldDim > | Class ExpressionInterpolateValue Class representing an interpolation in an expression |
►CExpressionBase< ExpressionScalar > | |
CExpressionScalar | Class ExpressionScalar Class representing a scalar constant in an expression |
►CExpressionBase< ExpressionScalarToVector< ExpressionType, FieldDim > > | |
CExpressionScalarToVector< ExpressionType, FieldDim > | |
►CExpressionBase< ExpressionSquareRoot< BaseExpressionType > > | |
CExpressionSquareRoot< BaseExpressionType > | Class ExpressionSquareRoot Class for representing a product between two expressions |
►CExpressionBase< ExpressionSubstraction< LExpressionType, RExpressionType > > | |
CExpressionSubstraction< LExpressionType, RExpressionType > | Class ExpressionSubstraction Class for representing a difference between two expressions |
►CExpressionBase< ExpressionSymmetricTensor< ExpressionType > > | |
CExpressionSymmetricTensor< ExpressionType > | Class ExpressionEmult Class for representing the transpose operation of an expression |
►CExpressionBase< ExpressionTrace< ExpressionType > > | |
CExpressionTrace< ExpressionType > | Class ExpressionEmult Class for representing the transpose operation of an expression |
►CExpressionBase< ExpressionTranspose< ExpressionType > > | |
CExpressionTranspose< ExpressionType > | Class ExpressionEmult Class for representing the transpose operation of an expression |
►CExpressionBase< ExpressionVector< VectorDim > > | |
CExpressionVector< VectorDim > | Class ExpressionVector Class representing a constant vectorial value in an expression |
►CExpressionBase< ExpressionVectorFromNonConstantMatrix< ExpressionType, SpaceDim, FieldDim > > | |
CExpressionVectorFromNonConstantMatrix< ExpressionType, SpaceDim, FieldDim > | Class ExpressionVector Class representing a constant vectorial value in an expression |
►CExpressionBase< ExpressionVectorFromNonConstantScalar< ExpressionType, FieldDim > > | |
CExpressionVectorFromNonConstantScalar< ExpressionType, FieldDim > | Class ExpressionEmult Class for representing the transpose operation of an expression |
CExpressionToEvaluation< Expression, testDim, solutionDim, spaceDim > | Class ExpressionToEvaluation A class to pass from an Expression (Tree) to the corresponding Evaluation (Tree) |
CExpressionToEvaluation< ExpressionType, 0, 0, 3 > | |
CExpressionToEvaluation< ExpressionType, 0, 0, MeshType::S_geoDimensions > | |
CExpressionToEvaluation< ExpressionType, SolutionSpaceType::field_dim, 0, MeshType::S_geoDimensions > | |
CExpressionToEvaluation< ExpressionType, SolutionTestSpace::field_dim, 0, 3 > | |
CExpressionToEvaluation< ExpressionType, TestSpaceType::field_dim, 0, 3 > | |
CExpressionToEvaluation< ExpressionType, TestSpaceType::field_dim, 0, MeshType::S_geoDimensions > | |
CExpressionToEvaluation< ExpressionType, TestSpaceType::field_dim, SolutionSpaceType::field_dim, 3 > | |
CExpressionToEvaluation< ExpressionType, TestSpaceType::field_dim, SolutionSpaceType::field_dim, MeshType::S_geoDimensions > | |
CExpressionToEvaluation< ExpressionType, TestSpaceType::S_fieldDim, 0, 3 > | |
CExpressionToEvaluation< ExpressionType, TestSpaceType::S_fieldDim, SolutionSpaceType::S_fieldDim, 3 > | |
CFaceHelp | |
►CfaceMarker_Type | |
CMeshElementMarked< 1, 2, GeoShape, MC > | Specialization for 1D entities (edges) in a 2D geometry. Identities of the adjacent 2D elements and their relative position are stored |
CMeshElementMarked< 2, 3, GeoShape, MC > | Specialization for 2D entities (faces) in a 3D geometry. Identities of the adjacent 3D elements and their relative position are stored |
Cfactory | Implements a generic object factory |
CFactoryDefaultError< AbstractProduct > | |
►CFactoryErrorPolicy | |
CFactory< AbstractProduct, IdentifierType, ProductCreator, FactoryErrorPolicy > | |
CFactoryPolicyCreationUsingNew< T > | |
CFactoryPolicyLifeTimeDefault< T > | |
CFactorySingleton< SingletonType > | Implement the FactorySingleton pattern |
CFactoryTypeInfo | |
CFastAssembler | |
CFastAssemblerMixed | |
CFastAssemblerNS | |
Cfefct | Includes |
CFEField< MeshType, MapType, ReturnType > | FEField - This class gives an abstract implementation of a finite element field |
►CFEField< MeshType, MapType, Real > | |
CFEScalarField< MeshType, MapType > | FEScalarField - This class gives an abstract implementation of a finite element scalar field |
►CFEField< MeshType, MapType, Vector > | |
CFEVectorField< MeshType, MapType > | FEVectorField - This class gives an abstract implementation of a finite element vector field |
►CFEFunction< MeshType, MapType, ReturnType > | FEFunction - This class gives an abstract implementation of a finite element function on finite elements fields |
CinitialCondition | |
CinversePermeability | Problem data |
CinversePermeability | Problem data |
CmassFunction | |
CMyFun | Data |
CreactionTerm | |
CreactionTerm | |
CscalarSource | |
CscalarSource | |
CvectorSource | |
CvectorSource | |
CFESpace< MeshType, MapType > | FESpace - Short description here please! |
CFESpace< LifeV::RegionMesh, LifeV::MapEpetra > | |
CFESpace< Mesh, LifeV::MapEpetra > | |
CfFunctor | |
CfibersDirectionList | |
CFiveNumbers | |
CFlowConditions | |
CFortranCharacterString | F77 compatible character class |
CFortranMatrix< ScalarType > | A matrix class for interfacing with fortran |
CFromTo | |
CFSI3DBoundaryAreaFunction | FSI3DBoundaryAreaFunction - The FSI3D area function |
CFSI3DBoundaryFlowRateFunction | FSI3DBoundaryFlowRateFunction - The FSI3D coupling function |
CFSI3DBoundaryStressFunction | FSI3DBoundaryStressFunction - The FSI3D coupling function |
CFSIChecker | |
CFSIcouplingCE | FSIcouplingCE - File handling the coupling blocks when conforming discretizations are used |
CFSIData | FSIData - Data container for FSI problems |
CFSIHandler | FSIHandler - File handling the solution of the FSI problem |
►CFSIOperator | Fluid-Structure Interface operator class |
CFSIExactJacobian | FSIModelExactJacobian - Implementation of an FSI (Operator) with Newton algorithm |
CFSIFixedPoint | FSIFixedPont - Implementation of an FSI with fixed point iterations |
►CFSIMonolithic | FSIMonolithic.hpp pure virtual class containing the core methods of the FSIMonolithic FSI solver |
CFSIMonolithicGE | |
CFSIMonolithicGI | FSIMonolithicGI Geometry-Implicit solver |
CFSISolver | Solver for Fluid-Structure Interaction |
CGeoDim< geoDimensions > | Dummy class for selecting correct function specializations based on geometry dimensions (1,2,3) |
CGeoDim< S_geoDimensions > | |
►CGeoShape | |
CMeshElement< GeoShape, PointType > | MeshVertex - Zero dimensional entity |
►CMeshElement< GeoShape, MeshElementMarked< 0, 1, GeoShape, MC > > | |
CMeshElementMarked< 1, 1, GeoShape, MC > | Specialization for 1D entities (edges) in 1D Geometry |
►CMeshElement< GeoShape, MeshElementMarked< 0, 2, GeoShape, MC > > | |
CMeshElementMarked< 2, 2, GeoShape, MC > | Specialization for 2D entities (faces) in a 2D geometry |
►CMeshElement< GeoShape, MeshElementMarked< 0, 3, GeoShape, MC > > | |
CMeshElementMarked< 3, 3, GeoShape, MC > | Specialization for 3D entities (cells) in a 3D geometry |
►CMeshElement< GeoShape::GeoBShape, MeshElementMarked< 0, 2, GeoShape, MC > > | |
CMeshElementMarked< 1, 2, GeoShape, MC > | Specialization for 1D entities (edges) in a 2D geometry. Identities of the adjacent 2D elements and their relative position are stored |
►CMeshElement< GeoShape::GeoBShape, MeshElementMarked< 0, 3, GeoShape, MC > > | |
CMeshElementMarked< 2, 3, GeoShape, MC > | Specialization for 2D entities (faces) in a 3D geometry. Identities of the adjacent 3D elements and their relative position are stored |
►CMeshElement< GeoShape::GeoBShape::GeoBShape, MeshElementMarked< 0, 3, GeoShape, MC > > | |
CMeshElementMarked< 1, 3, GeoShape, MC > | Specialization for 1D entities (edges) in 3D geometry |
CGetCoordComponent | This functor is used to do some geometry checks |
CGetOnes | |
CGetPot | |
CGhostEntityData | Ghost entity data structure |
CGhostHandler< MeshType > | GhostHandler |
Cgmsh_elm_t | |
CgradExactFunctor | |
CgradUExactFunctor | |
►CGraphCutterBase< MeshType > | Graph cutter base class (abstract) |
CGraphCutterParMETIS< MeshType > | Class that partitions the graph associated with a mesh (ParMETIS version) |
CGraphCutterZoltan< MeshType > | Class that partitions the graph associated with a mesh |
CGraphElement< MeshType, TestSpaceType, SolutionSpaceType, ExpressionType > | The class to actually perform the loop over the elements to precompute a graph |
CGRobinRhsFunctor | |
CHarmonicExtension | |
CHarmonicExtensionSolver< Mesh, SolverType > | |
CHeart | |
CHeartBidomainSolver< Mesh, SolverType > | |
CHeartFunctors | |
►CHeartIonicSolver< Mesh, SolverType > | IonicSolver - This class implements a ionic model solver |
CLuoRudy< Mesh, SolverType > | |
CMitchellSchaeffer< Mesh, SolverType > | |
CRogersMcCulloch< Mesh, SolverType > | |
CHeartMonodomainSolver< Mesh, SolverType > | MonodomainSolver - Class featuring the usual solver for monodomain equations |
CHeavisideFct | |
CHeavisideFunctor | |
►CHexa | |
CLinearHexa | A Geometric Shape |
CQuadraticHexa | A Geometric Shape |
Chyperbolic | Includes |
CHyperbolicData< Mesh > | |
CHyperbolicSolver< Mesh, SolverType > | HyperbolicSolver Implements an hyperbolic solver |
Cid_of< geoshape > | |
CIdGetter< Selector > | Generic definition of the functor to extract the local or global ID |
Cimpes | |
CImplicitResistance | |
CImporter | Importer General interface for read different types of mesh |
CInitPolicyInterpolation< mesh_Type > | |
►Cinspector | |
►Chypertext_inspector | |
Clink_check | |
Clong_name_check | |
Cminmax_check | |
►Csource_inspector | |
Ccopyright_check | |
Ccrlf_check | |
Clicense_check | |
Ctab_check | |
Cinspector_element | |
CIntegrateMatrixElement< MeshType, TestSpaceType, SolutionSpaceType, ExpressionType, QRAdapterType > | The class to actually perform the loop over the elements to assemble a matrix |
CIntegrateMatrixElementLSAdapted< MeshType, TestSpaceType, SolutionSpaceType, ExpressionType, LSFESpaceType, LSVectorType > | The class to actually perform the loop over the elements to assemble a matrix |
CIntegrateMatrixFaceID< MeshType, TestSpaceType, SolutionSpaceType, ExpressionType > | The class to actually perform the loop over the elements to assemble a vector |
CIntegrateMatrixFaceIDLSAdapted< MeshType, TestSpaceType, SolutionSpaceType, ExpressionType, LSFESpaceType, LSVectorType > | The class to actually perform the loop over the elements to assemble a vector |
CIntegrateMatrixVolumeID< MeshType, TestSpaceType, SolutionSpaceType, ExpressionType, QRAdapterType > | The class to actually perform the loop over the elements to assemble a vector |
CIntegrateValueElement< MeshType, ExpressionType, QRAdapterType > | The class to actually perform the loop over the elements to compute a value |
CIntegrateValueElementLSAdapted< MeshType, ExpressionType, LSFESpaceType, VectorType > | IntegrateValueElementLSAdapted - Class to integrate a value using a quadrature conforming to a level set |
CIntegrateVectorElement< MeshType, TestSpaceType, ExpressionType, QRAdapterType > | The class to actually perform the loop over the elements to assemble a vector |
CIntegrateVectorElementLSAdapted< MeshType, TestSpaceType, ExpressionType, LSFESpaceType, LSVectorType > | The class to actually perform the loop over the elements to assemble a vector using special QR |
CIntegrateVectorFaceID< MeshType, TestSpaceType, ExpressionType > | The class to actually perform the loop over the elements to assemble a vector |
CIntegrateVectorFaceIDLSAdapted< MeshType, TestSpaceType, ExpressionType, LSFESpaceType, LSVectorType > | The class to actually perform the loop over the elements to assemble a vector |
CIntegrateVectorVolumeID< MeshType, TestSpaceType, ExpressionType, QRAdapterType > | The class to actually perform the loop over the elements to assemble a vector |
CInterpolation | |
CisNullFinder< T > | |
CisNullFinder< char * > | |
CisNullFinder< const char * > | |
CKimMoin | |
Claplacian | Includes |
ClaplacianExact | |
CLaplacianExactFunctor | |
ClaplacianExactGradient | |
ClaplacianFunctor< Return_Type > | |
ClaplacianSource | |
CLevelSetBDQRAdapter< FESpaceType, VectorType > | |
CLevelSetBDQRAdapter< LSFESpaceType, LSVectorType > | |
CLevelSetInterrogator< MeshEntityType > | |
CLifeChrono | |
CLifeChronoFake | |
CLifeChronoManager< TimerType > | |
►CLine | |
CLinearLine | A Geometric Shape |
CQuadraticLine | A Geometric Shape |
CLinearElasticity | |
CLinearSolver | LinearSolver - Class to wrap linear solver |
ClineDistance | |
CLumpedHeart | |
►Cmap | |
CMeshElementBareHandler< BareItemType > | MeshElementBareHandler class - Class to handle bare edges and faces construction |
CSwitch | I use standard constructor/destructors |
CMapEpetra | MapEpetra - Wrapper for Epetra_Map |
CMapEpetraData | MapEpetraData |
CMapVector< MapType > | This class is used to store maps that will be used for block defined problems |
CMarker< MarkerIDPolicy > | Marker - Base marker class |
►CMarker< FlagPolicy > | |
CNeighborMarker< FlagPolicy > | |
CMarkerCommon< MT > | MarkerCommon - A trait class that defines the markers used in RegionMesh |
CMarkerIDStandardPolicy | MarkerIDStandardPolicy - Class that defines the standard policies on Marker Ids |
CMarkerSelector< MeshEntityType, ComparisonPolicyType > | |
CMatriceCreuseDivKN_< R > | |
CMatriceCreuseMulKN_< R > | |
CMatrixBlockMonolithicEpetraView< DataType > | MatrixBlockMonolithicEpetraView - class representing a block in a MatrixBlockMonolithicEpetra |
CMatrixBlockStructure | MatrixBlockStructure - class representing the structure of a vector |
CMatrixContainer< KEYTYPE > | |
CMatrixElemental | |
►CMatrixEpetra< DataType > | MatrixEpetra - The Epetra Matrix format Wrapper |
CMatrixBlockMonolithicEpetra< DataType > | MatrixBlockMonolithicEpetra - class of block matrix |
CMatrixEpetraStructured< DataType > | MatrixEpetraStructured - class of block matrix |
CMatrixEpetraStructuredView< DataType > | MatrixEpetraStructuredView - class representing a block in a MatrixEpetraStructured |
CMatrixGraph | |
CMatrixSmall< Dim1, Dim2 > | Class VectorSmall This class implements a simple vector |
CMatrixSmall< 3, 3 > | |
CMatrixSmall< MatrixDim1, MatrixDim2 > | |
CMeshColoring | MeshData - class for coloring mesh |
►CMeshData | MeshData - class for handling spatial discretization |
CHeartBidomainData | |
CHeartIonicData | |
CHeartMonodomainData | |
►CMeshEntity | This is the base class to store basic properties of any mesh entity |
CMeshElement< GeoShape, PointType > | MeshVertex - Zero dimensional entity |
►CMeshVertex | MeshVertex - Zero dimensional entity |
CMeshElementMarked< elemDim, geoDim, GeoShape, MC > | Class for describing a geometric Entity immersed in 1D, 2D or 3D Geometry |
CMeshElementMarked< 0, 1, GeoShape, MC > | Specialization for 0D entities (points) in 1D Geometry |
CMeshElementMarked< 0, geoDim, GeoShape, MC > | Specialization for 0D entities (points) |
CMeshElementMarked< S_peakDimension, S_geoDimensions, geoShape_Type, markerCommon_Type > | |
CMeshElementMarked< S_ridgeDimension, S_geoDimensions, geoShape_Type, markerCommon_Type > | |
CRegionMesh< GeoShapeType, MCType > | Class for 3D, 2D and 1D Mesh |
CMeshElement< GeoShape, MeshElementMarked< 0, 1, GeoShape, MC > > | |
CMeshElement< GeoShape, MeshElementMarked< 0, 2, GeoShape, MC > > | |
CMeshElement< GeoShape, MeshElementMarked< 0, 3, GeoShape, MC > > | |
CMeshElement< GeoShape::GeoBShape, MeshElementMarked< 0, 2, GeoShape, MC > > | |
CMeshElement< GeoShape::GeoBShape, MeshElementMarked< 0, 3, GeoShape, MC > > | |
CMeshElement< GeoShape::GeoBShape::GeoBShape, MeshElementMarked< 0, 3, GeoShape, MC > > | |
CRegionMesh< geoShape_Type, markerCommon_Type > | |
CMeshPartBuilder< MeshType > | Class that builds a mesh part, after the graph has been partitioned |
CMeshPartitioner< MeshType > | Class that handles mesh partitioning |
CMeshPartitionerOfflineFSI< MeshType > | MeshPartitionerOfflineFSI - Offline mesh partitioning for FSI |
CMeshPartitionTool< MeshType > | Class that does flexible mesh partitioning |
CmeshSize | It holds statistics on mesh size |
CMeshTransformer< REGIONMESH, RMTYPE > | Class to transform a mesh |
CMeshTransformer< LifeV::RegionMesh< geoShape_Type, markerCommon_Type >, markerCommon_Type > | |
CMeshVolumeSubdivision< MeshType > | MeshVolumeSubdivision |
CMMHFunctor | |
CMMSV | |
CMMTanhFunctor | |
►CMonolithicBlock | MonolithicBlock - This is a pure virtual class for the linear operators with a block structure |
►CMonolithicBlockComposed | MonolithicBlockComposed - Class handling block-structured preconditioners |
►CMonolithicBlockComposedDN | MonolithicBlockComposedDN - Short description of the class |
CMonolithicBlockComposedDND | MonolithicBlockComposedDND - Modular preconditioner for (e.g.) geometry implicit monolithic FSI, three factors splitting |
CMonolithicBlockComposedNN | MonolithicBlockComposedNN - Short description of the class |
►CMonolithicBlockMatrix | MonolithicBlockMatrix - class which handles matrices with a block structure |
CMonolithicBlockMatrixRN | MonolithicBlockMatrixRN - class for handling a 2-blocks matrix with Robin-Neumann coupling |
►CMonolithicRobinInterface | MonolithicRobinInterface - Class for the Robin coupling of etherogeneaous problems |
CMonolithicBlockMatrixRN | MonolithicBlockMatrixRN - class for handling a 2-blocks matrix with Robin-Neumann coupling |
CMul_KNM_KN_< R > | |
CMulc_KN_< R > | |
►CMultiscaleAlgorithm | MultiscaleAlgorithm - The Multiscale Algorithm Interface |
CMultiscaleAlgorithmAitken | MultiscaleAlgorithmAitken - The Multiscale Algorithm implementation of Aitken |
CMultiscaleAlgorithmBroyden | MultiscaleAlgorithmBroyden - The Multiscale Algorithm implementation of Broyden |
CMultiscaleAlgorithmExplicit | MultiscaleAlgorithmExplicit - The Multiscale Algorithm implementation of Explicit |
CMultiscaleAlgorithmNewton | MultiscaleAlgorithmNewton - The Multiscale Algorithm implementation of Newton |
CMultiscaleCommunicatorsManager | MultiscaleCommunicatorsManager - The Multiscale Communicators Manager |
►CMultiscaleCoupling | MultiscaleCoupling - The Multiscale Physical Coupling |
CMultiscaleCouplingBoundaryCondition | MultiscaleCouplingBoundaryCondition - Coupling condition for standard boundary conditions |
►CMultiscaleCouplingMeanNormalStress | MultiscaleCouplingMeanNormalStress - Stress coupling condition |
CMultiscaleCouplingMeanNormalStressArea | MultiscaleCouplingMeanNormalStressArea - Mean normal stress with area coupling condition |
CMultiscaleCouplingMeanNormalStressValve | MultiscaleCouplingMeanNormalStressValve - Mean normal stress coupling condition with simple valve |
►CMultiscaleCouplingMeanTotalNormalStress | MultiscaleCouplingMeanTotalNormalStress - Stress coupling condition |
CMultiscaleCouplingMeanTotalNormalStressArea | MultiscaleCouplingMeanTotalNormalStressArea - Mean normal stress with area coupling condition |
CMultiscaleCouplingFunction | MultiscaleCouplingFunction - The multiscale function for the couplings |
CMultiscaleGlobalData | MultiscaleGlobalData - Global data container for the physical quantities of the problem |
►CMultiscaleInterface | MultiscaleInterface - The multiscale interface for fluid problems |
CMultiscaleModelFluid3D | MultiscaleModelFluid3D - Multiscale model for 3D Fluid simulations |
CMultiscaleModelFSI1D | MultiscaleModelFSI1D - Multiscale model for 1D Fluid simulations |
CMultiscaleModelFSI3D | MultiscaleModelFSI3D - Multiscale model for 3D FSI simulations |
CMultiscaleModelWindkessel0D | MultiscaleModelWindkessel0D - Multiscale model for Windkessel 0D terminals |
►CMultiscaleModel | MultiscaleModel - The Multiscale Physical Model |
CMultiscaleModel0D | MultiscaleModel0D - Multiscale model for 0D simulations |
CMultiscaleModelFluid3D | MultiscaleModelFluid3D - Multiscale model for 3D Fluid simulations |
CMultiscaleModelFSI1D | MultiscaleModelFSI1D - Multiscale model for 1D Fluid simulations |
CMultiscaleModelFSI3D | MultiscaleModelFSI3D - Multiscale model for 3D FSI simulations |
CMultiscaleModelMultiscale | MultiscaleModelMultiscale - Multiscale model |
CMultiscaleModelWindkessel0D | MultiscaleModelWindkessel0D - Multiscale model for Windkessel 0D terminals |
CMultiscaleSolver | MultiscaleSolver - The Multiscale solver |
CNavierStokes< MeshType, Problem > | NavierStokes Simulation class |
CNavierStokesProblem< mesh_Type > | |
►CNavierStokesProblem< esMesh_Type > | |
CNavierStokesEthierSteinman | |
►CNavierStokesProblem< RegionMesh< LinearTetra > > | |
CNavierStokesCavity | |
CNavierStokesSolverBlocks | |
CNdebugStream | |
CNeighborMarkerCommon< MT > | |
CNeoHookean | |
CNewmark | |
►Cnoncopyable | |
Ccvs_iterator | |
CNonLinearAitken< VectorType > | NonLinearAitken - LifeV class for the non-linear generalized Aitken algorithm |
CNonLinearAitken< fluidVector_Type > | |
CNonLinearAitken< LifeV::VectorEpetra > | |
CNonLinearAitken< vector_Type > | |
CNorm | |
CNormalizeFct | |
CNormalizeFct | |
CNormFct | |
CnormFunctor | |
CnullShape | |
COneDFSIBC | OneDFSIBC - Class featuring methods to handle boundary conditions |
COneDFSIBCHandler | OneDFSIBCHandler - Class featuring methods to handle boundary conditions |
COneDFSIData | OneDFSIData - Class which read and holds all the data for the One Dimensional Model Solver |
►COneDFSIFlux | OneDFSIFlux - Base class for the flux term of the 1D hyperbolic problem |
COneDFSIFluxLinear | OneDFSIFluxLinear - Class containing the linear flux term of the 1D hyperbolic problem |
COneDFSIFluxNonLinear | OneDFSIFluxNonLinear - Class containing the non-linear flux term of the 1D hyperbolic problem |
COneDFSIFunction | OneDFSIFunction - Base class for 1D BC Functions |
►COneDFSIFunctionSolverDefined | OneDFSIModelBCFunctionDefault - Base class for deriving specific 1D boundary functions |
►COneDFSIFunctionSolverDefinedRiemann | OneDFSIFunctionSolverDefinedRiemann - Class which implements Riemann boundary conditions for the 1D segment |
►COneDFSIFunctionSolverDefinedCompatibility | OneDFSIFunctionSolverDefinedCompatibility - Class which implements Compatibility boundary conditions for the 1D segment |
►COneDFSIFunctionSolverDefinedAbsorbing | OneDFSIFunctionSolverDefinedAbsorbing - Class which implements absorbing boundary conditions for the 1D segment |
COneDFSIFunctionSolverDefinedResistance | OneDFSIFunctionSolverDefinedResistance - Class which implements resistance boundary conditions for the 1D segment |
COneDFSIFunctionSolverDefinedWindkessel3 | OneDFSIFunctionSolverDefinedWindkessel3 - Class which implements windkessel RCR boundary conditions for the 1D segment |
►COneDFSIPhysics | OneDFSIPhysics - Base class providing physical operations for the 1D model data |
COneDFSIPhysicsLinear | OneDFSIPhysicsLinear - Class providing linear physical operations for the 1D model data |
COneDFSIPhysicsNonLinear | OneDFSIPhysicsNonLinear - Class providing non linear physical operations for the 1D model data |
COneDFSISolver | OneDFSISolver - Solver class for the 1D model |
►COneDFSISource | OneDFSISource - Base class for the source term of the 1D hyperbolic problem |
COneDFSISourceLinear | OneDFSISourceLinear - Class for the linear source function S of the 1D hyperbolic problem |
COneDFSISourceNonLinear | OneDFSISourceNonLinear - Class for the non-linear source function B of the 1D hyperbolic problem |
COpenMPParameters | OpenMP parameter class |
COperationSmallAddition< LeftOperand, RightOperand > | Class OperationSmallAddition Class containing information about the addition operation between the *Small classes |
COperationSmallArcTan< Base > | Class OperationSmallAddition Class containing information about the power operation between the *Small classes |
COperationSmallCubicRoot< Argument > | Class OperationSmallAddition Class containing information about the power operation between the *Small classes |
COperationSmallDerivativeArcTan< Base > | Class OperationSmallAddition Class containing information about the power operation between the *Small classes |
COperationSmallDeterminant< Operand > | Class OperationSmallTranspose Class containing information about the transpose operation for Small* classes |
COperationSmallDivision< LeftOperand, RightOperand > | Class OperationSmallDivision Class containing information about the division operation between *Small classes |
COperationSmallDot< LeftOperand, RightOperand > | Class OperationSmallDot Class containing information about the dot product operation between Small* classes |
COperationSmallEmult< LeftOperand, RightOperand > | Class OperationSmallEmult Class containing information about the element-wise multiplication product operation between Small* classes |
COperationSmallExponential< Argument > | Class OperationSmallAddition Class containing information about the power operation between the *Small classes |
COperationSmallExtract1< Operand > | Class OperationSmallExtract Class containing information about the extraction of a row or component within Small* classes |
COperationSmallExtract2< Operand > | |
COperationSmallInverse< Operand > | Class OperationSmallTranspose Class containing information about the transpose operation for Small* classes |
COperationSmallLogarithm< Base > | Class OperationSmallAddition Class containing information about the power operation between the *Small classes |
COperationSmallMinusTranspose< Operand > | Class OperationSmallTranspose Class containing information about the transpose operation for Small* classes |
COperationSmallNormalize< Operand > | Class OperationSmallTranspose Class containing information about the transpose operation for Small* classes |
COperationSmallOuterProduct< LeftOperand, RightOperand > | Class OperationSmallOuterProduct Class containing information about the element-wise multiplication product operation between Small* classes |
COperationSmallPower< Base, Exponent > | Class OperationSmallAddition Class containing information about the power operation between the *Small classes |
COperationSmallProduct< LeftOperand, RightOperand > | Class OperationSmallProduct Class containing information about the product operation between *Small classes |
COperationSmallSquareRoot< Argument > | Class OperationSmallAddition Class containing information about the power operation between the *Small classes |
COperationSmallSubstraction< LeftOperand, RightOperand > | Class OperationSmallSubstraction Class containing information about the substraction operation between *Small classes |
COperationSmallSymmetricTensor< Operand > | Class OperationSmallTranspose Class containing information about the transpose operation for Small* classes |
COperationSmallTrace< Operand > | Class OperationSmallTranspose Class containing information about the transpose operation for Small* classes |
COperationSmallTranspose< Operand > | Class OperationSmallTranspose Class containing information about the transpose operation for Small* classes |
COseen | |
COseenAssembler< meshType, matrixType, vectorType > | OseenAssembler - Assembly class for the Oseen problem |
COseenData | OseenData - LifeV Base class which holds usual data for the NavierStokes equations solvers |
►COseenSolver< MeshType, SolverType > | This class contains an Oseen equation solver |
COseenSolverShapeDerivative< MeshType, SolverType > | This class contains an Oseen equation solver class with shape derivative for fluid structure interaction problem |
COutflow | 2D/3D Cylinder Simulation class |
COutPutFormat | OutPutFormat - Write to output |
CParser | Parser - A string parser for algebraic expressions |
Cpartitioner< dim > | |
Cpartitioner< 1 > | |
Cpartitioner< 2 > | |
CpExactFunctor | |
CPhysiologicalFlux | PhysiologicalFlux - Base class for One Dimensional BC Functions |
►CPoint | |
CGeoPoint | A Geometric Shape |
►CpointMarker_Type | |
CMeshElementMarked< 0, 1, GeoShape, MC > | Specialization for 0D entities (points) in 1D Geometry |
CMeshElementMarked< 0, geoDim, GeoShape, MC > | Specialization for 0D entities (points) |
CPostProcessingBoundary< MeshType > | Class with methods to manage fields defined on the domain boundary |
►CPreconditioner | Preconditioner - Abstract preconditioner class |
CPreconditionerAztecOO | PreconditionerAztecOO - The implementation of Preconditioner for AztecOO preconditioners |
CPreconditionerBlock | PreconditionerBlock |
CPreconditionerComposed | PreconditionerComposed - |
►CPreconditionerComposition | PreconditionerComposition - Class to manage preconditioners composed by matrices multiplication |
CPreconditionerPCD | PreconditionerPCD |
CPreconditionerSIMPLE | PreconditionerSIMPLE |
CPreconditionerYosida | PreconditionerYosida |
CPreconditionerIfpack | PreconditionerIfpack - Class implementing overlapping Schwarz preconditioner |
CPreconditionerLinearSolver | PreconditionerLinearSolver - Class to wrap linear solver |
CPreconditionerML | PreconditionerML - Class of multilevels preconditioner |
CPressureRamp | PressureRamp |
CDebugStream::Private | |
CNavierStokes< MeshType, Problem >::Private | |
Ctest_bdf::Private | Private Members |
Cfefct::Private | Private Members |
Cdarcy_nonlinear::Private | Private Members |
CETRobinMembraneSolver::Private | |
Cdarcy_linear::Private | Private Members |
CWSS::Private | |
CStructure::Private | |
Cproblem::Private | Private members |
Chyperbolic::Private | Private Members |
CResistanceTest::Private | |
Cimpes::Private | Private Members |
CCylinder::Private | |
CEnsightToHdf5::Private | |
Cproblem | Includes |
CProblem | |
CQRAdapterBase< ImplementationType > | |
►CQRAdapterBase< MCQuadrature< MeshType > > | |
CMCQuadrature< MeshType > | |
►CQRAdapterBase< QRAdapterNeverAdapt > | |
CQRAdapterNeverAdapt | |
CQRKeast< degree > | QRKeast - A set of quadrature for tetrahedra |
CQRKeast< 1 > | |
CQRKeast< 4 > | |
CQRKeast< 6 > | |
CQRKeast< 7 > | |
►CQuad | |
CLinearQuad | A Geometric Shape |
CQuadraticQuad | A Geometric Shape |
CQuadratureBoundary | QuadratureBoundary - Short description of the class |
CQuadraturePoint | QuadraturePoint - Simple container for a point of a quadrature rule |
CQuadratureRule | QuadratureRule - The basis class for storing and accessing quadrature rules |
CQuadratureRuleBoundary | QuadratureRuleBoundary - Short description of the class |
CQuadratureRuleProvider | QuadratureRuleProvider - This class is used to generate quadrature rules |
►CRBFInterpolation< mesh_Type > | |
CRBFlocallyRescaledScalar< mesh_Type > | |
CRBFlocallyRescaledVectorial< mesh_Type > | |
CRBFrescaledScalar< mesh_Type > | |
CRBFrescaledVectorial< mesh_Type > | |
►CReferenceElement | ReferenceElement - The basis class for the geometric mapping and the reference finite elements |
CGeometricMap | GeometricMap - Structure for the geometrical mapping |
CReferenceFE | The class for a reference Lagrangian finite element |
CRefHybridFE | Class for Hybrid functions, i.e. defined on the boundary of an element |
CRequestLoopElement< MeshType > | RequestLoopElement - The class to request a loop over the elements of a mesh |
CRequestLoopFaceID< MeshType > | |
CRequestLoopVolumeID< MeshType > | |
CResetFlag< meshEntity > | |
CResistanceBCs | |
CResistanceTest | 2D/3D Cylinder Simulation class |
CProblem::RESULT_CHANGED_EXCEPTION | |
CNavierStokes< MeshType, Problem >::RESULT_CHANGED_EXCEPTION | |
CRossEthierSteinmanUnsteadyDec | |
CRossEthierSteinmanUnsteadyInc | |
CSelectionFunctor | |
CSetofFun | |
►Cshape_id< id > | |
Cregister_shape< shape, id > | |
►Cregister_shape< LifeV::GeoPoint, 15 > | |
Cid_of< LifeV::GeoPoint > | |
►Cregister_shape< LifeV::LinearHexa, 5 > | |
Cid_of< LifeV::LinearHexa > | |
►Cregister_shape< LifeV::LinearLine, 1 > | |
Cid_of< LifeV::LinearLine > | |
►Cregister_shape< LifeV::LinearQuad, 3 > | |
Cid_of< LifeV::LinearQuad > | |
►Cregister_shape< LifeV::LinearTetra, 4 > | |
Cid_of< LifeV::LinearTetra > | |
►Cregister_shape< LifeV::LinearTriangle, 2 > | |
Cid_of< LifeV::LinearTriangle > | |
►Cregister_shape< LifeV::nullShape, 0 > | |
Cid_of< LifeV::nullShape > | |
►Cregister_shape< LifeV::QuadraticHexa, 12 > | |
Cid_of< LifeV::QuadraticHexa > | |
►Cregister_shape< LifeV::QuadraticLine, 8 > | |
Cid_of< LifeV::QuadraticLine > | |
►Cregister_shape< LifeV::QuadraticQuad, 10 > | |
Cid_of< LifeV::QuadraticQuad > | |
►Cregister_shape< LifeV::QuadraticTetra, 11 > | |
Cid_of< LifeV::QuadraticTetra > | |
►Cregister_shape< LifeV::QuadraticTriangle, 9 > | |
Cid_of< LifeV::QuadraticTriangle > | |
Cshape_type< T > | |
►Cshape_type< LifeV::GeoPoint > | |
Cregister_shape< LifeV::GeoPoint, 15 > | |
►Cshape_type< LifeV::LinearHexa > | |
Cregister_shape< LifeV::LinearHexa, 5 > | |
►Cshape_type< LifeV::LinearLine > | |
Cregister_shape< LifeV::LinearLine, 1 > | |
►Cshape_type< LifeV::LinearQuad > | |
Cregister_shape< LifeV::LinearQuad, 3 > | |
►Cshape_type< LifeV::LinearTetra > | |
Cregister_shape< LifeV::LinearTetra, 4 > | |
►Cshape_type< LifeV::LinearTriangle > | |
Cregister_shape< LifeV::LinearTriangle, 2 > | |
►Cshape_type< LifeV::nullShape > | |
Cregister_shape< LifeV::nullShape, 0 > | |
►Cshape_type< LifeV::QuadraticHexa > | |
Cregister_shape< LifeV::QuadraticHexa, 12 > | |
►Cshape_type< LifeV::QuadraticLine > | |
Cregister_shape< LifeV::QuadraticLine, 8 > | |
►Cshape_type< LifeV::QuadraticQuad > | |
Cregister_shape< LifeV::QuadraticQuad, 10 > | |
►Cshape_type< LifeV::QuadraticTetra > | |
Cregister_shape< LifeV::QuadraticTetra, 11 > | |
►Cshape_type< LifeV::QuadraticTriangle > | |
Cregister_shape< LifeV::QuadraticTriangle, 9 > | |
►Cshape_type< shape > | |
Cregister_shape< shape, id > | |
►CShapeOfArray | |
►CKN_< double > | |
CKN< double > | |
►CKN_< Real > | |
►CKN< Real > | |
CVectorElemental | |
►CKNM_< Real > | |
CKNM< Real > | |
►CKN_< R > | |
CKN< R > | |
►CKNM_< R > | |
CKNM< R > | |
►CKNMK_< R > | |
CKNMK< R > | |
►CKNMKL_< R > | |
CKNMKL< R > | |
CSignFct | |
CSignFunction | |
CSin | Sin - Sinusoidal wave |
CSmoothDeltaFct | |
CSolverAmesos | SolverAmesos - Class to wrap linear solver |
CSolverAztecOO | SolverAztecOO - Class to wrap linear solver |
CZeroDimensionalData::SolverData | Rhytmos solver data container |
►CSolverPolicy | |
CInitPolicyProjection< mesh_Type, SolverPolicy > | |
CTimeIterationPolicyLinear< mesh_Type, AssemblyPolicy, SolverPolicy > | |
CTimeIterationPolicyNonlinear< mesh_Type, AssemblyPolicy, SolverPolicy > | |
CTimeIterationPolicyNonlinearIncremental< mesh_Type, AssemblyPolicy, SolverPolicy > | |
CSolverPolicyLinearSolver | |
CSourceFct | |
CSourceFct_2d | User functions |
CsourceVectorialFunctor | |
CSphereCounter< MeshEntityType, ComparisonPolicyType > | |
CSphereInterrogator< MeshEntityType, ComparisonPolicyType > | |
CSquareRoot | |
CSquareRoot_supg_semi_implicit | |
CSquareRoot_supg_semi_implicit_ale | |
CSquareRoot_SUPGALE | |
►CStabilization | |
CStabilizationSUPG | |
CStabilizationSUPG_semi_implicit | |
CStabilizationSUPG_semi_implicit_ale | |
CStabilizationSUPGALE | |
CStabilizationIP< MeshType, DofType > | StabilizationIP Class |
CStabilizationIP< LifeV::RegionMesh, LifeV::DOF > | |
CStabilizationSD< MeshType, DofType > | StabilizationSD Class |
CStimulusPMJ::StimulusPMJ_Activation | |
CStreamHolder | |
CStringData | |
CStringDataList | |
►CStructuralAnisotropicConstitutiveLaw< MeshType > | |
CAnisotropicMultimechanismMaterialNonLinear< MeshType > | |
CDistributedHolzapfelMaterialNonLinear< MeshType > | |
CHolzapfelGeneralizedMaterialNonLinear< MeshType > | |
CHolzapfelMaterialNonLinear< MeshType > | |
CStructuralConstitutiveLaw< MeshType > | This class is an abstract class to define different type of models for the arterial wall. This class has just pure virtual methods. They are implemented in the specific class for one material |
CStructuralConstitutiveLawData | DataElasticStructure - Data container for solid problems with elastic structure |
►CStructuralIsotropicConstitutiveLaw< MeshType > | |
CExponentialMaterialNonLinear< MeshType > | |
CNeoHookeanMaterialNonLinear< MeshType > | |
CSecondOrderExponentialMaterialNonLinear< MeshType > | |
CVenantKirchhoffMaterialLinear< MeshType > | |
CVenantKirchhoffMaterialNonLinear< MeshType > | |
CVenantKirchhoffMaterialNonLinearPenalized< MeshType > | |
CStructuralOperator< Mesh > | |
CStructuralSolver | This class solves the linear elastodynamics equations for different kinds of materials (St. Venant-Kirchoff materials right now) |
CStructure | |
CSub_KN_< R > | |
CSubArray | |
Ctest_bdf | |
Ctester< S > | |
CTestImportExport | |
CTestRepeatedMesh< Dim > | |
►CTetra | |
CLinearTetra | A Geometric Shape |
CLinearTetraBubble | A Geometric Shape |
CQuadraticTetra | A Geometric Shape |
►CTimeAdvance< feVectorType > | TimeAdvance_template - File containing a class to deal the time advancing scheme |
CTimeAdvanceBDF< feVectorType > | Class TimeAdvanceBDF - Backward differencing formula time discretization for the first and the second order problem in time |
CTimeAdvanceNewmark< feVectorType > | TimeAdvanceNewmark - Class to deal the -method and TimeAdvanceNewmark scheme |
►CTimeAdvance< double > | |
CTimeAdvanceBDF< double > | |
►CTimeAdvance< vector_Type > | |
CTimeAdvanceBDF< vector_Type > | |
►CTimeAdvance< VectorType > | |
CTimeAdvanceBDF< VectorType > | |
CTimeAdvanceBDFNavierStokes< VectorType > | |
CTimeAdvanceBDFVariableStep< FEVectorType > | TimeAdvanceBDFVariableStep - Backward differencing formula time discretization with non-uniform time step |
CTimeAdvanceData | TimeAdvanceData - Class for handling temporal discretization |
CTimeAndExtrapolationHandler | |
CTimeAndExtrapolationHandlerQuadPts< DIM > | |
►CTimeData | TimeData - Class for handling temporal discretization |
CHeartBidomainData | |
CHeartIonicData | |
CHeartMonodomainData | |
►CTimeIterationPolicy | |
CInitPolicySolver< mesh_Type, TimeIterationPolicy > | |
CNavierStokesSolver< Mesh, InitPolicy, TimeIterationPolicy, ExporterPolicy > | |
CTransportBuffer | This structure is used to pack objects in the Zoltan migration phase |
►CTriangle | |
CLinearTriangle | A Geometric Shape |
CQuadraticTriangle | A Geometric Shape |
Ctwophase_impes | Includes |
CuExactFunctor | |
CuExactFunctor | |
CGetPot::variable | |
►Cvector | |
CArraySimple< double > | |
CArraySimple< UInt > | |
CdummyVect | Includes |
CdummyVect | Includes |
CArraySimple< DataType > | ArraySimple |
CMeshEntityContainer< DataType, Allocator > | |
CMeshEntityContainer< edge_Type > | |
CMeshEntityContainer< face_Type > | |
CMeshEntityContainer< point_Type > | |
CMeshEntityContainer< volume_Type > | |
CVectorBlockMonolithicEpetraView | VectorBlockMonolithicEpetraView - class representing a block in a VectorBlockMonolithicEpetra |
CVectorBlockStructure | VectorBlockStructure - class representing the structure of a vector |
CVectorContainer< VectorType, ContainerType > | VectorContainer - LifeV vector composed by concatenating other vectors |
►CVectorEpetra | VectorEpetra - The Epetra Vector format Wrapper |
CVectorBlockMonolithicEpetra | VectorBlockMonolithicEpetra - class of block vector |
CVectorEpetraStructured | VectorEpetraStructured - class of block vector |
CVectorEpetraStructuredView | VectorEpetraStructuredView - class representing a block in a VectorEpetraStructuredView |
CVectorSmall< Dim > | |
CVectorSmall< 3 > | Class VectorSmall<3> Partial specialization for the 3D case |
CVectorSmall< FieldDim > | |
CVectorSmall< VectorDim > | |
►CVenantKirchhoffElasticData | |
CVenantKirchhoffElasticHandler< Mesh > | |
CVenantKirchhoffViscoelasticData | |
CVenantKirchhoffViscoelasticSolver< Mesh, SolverType > | SecondOrderProblem this class solver second order problem, waves equation and linear viscoelastic problem |
CVerifySolutions | This class helps the testsuites in verifying that the solutions do not change from one execution to the other |
CViscosityFct | |
►CvolumeMarker_Type | |
CMeshElementMarked< 2, 2, GeoShape, MC > | Specialization for 2D entities (faces) in a 2D geometry |
CMeshElementMarked< 3, 3, GeoShape, MC > | Specialization for 3D entities (cells) in a 3D geometry |
CWallClock | Wall clock timer class |
►CWallTensionEstimator< Mesh > | This class lets to compute the wall tensions inside the arterial wall. The tensorial operations that are needed to compute the stress tensor are defined in AssemblyElementalStructure. When a new type of analysis wants to be performed new methods can be added |
CWallTensionEstimatorCylindricalCoordinates< Mesh > | |
CWallTensionEstimatorData | DataElasticStructure - Data container for solid problems with elastic structure |
CWomersley | |
CWRONG_PREC_EXCEPTION | |
CWSS | |
CZeroDimensionalBC | ZeroDimensionalBC - A boundary condition for zero-dimensional models |
CZeroDimensionalBCHandler | ZeroDimensionalBCHandler - A boundary conditions handler for zero-dimensional models |
CZeroDimensionalCircuitData | ZeroDimensionalCircuitData - Container of circuit data |
CZeroDimensionalData | Data container for 0D model |
►CZeroDimensionalElement | ZeroDimensionalElement - The base element class |
►CZeroDimensionalElementPassive | ZeroDimensionalElementPassive - A class for passive elements |
CZeroDimensionalElementPassiveCapacitor | ZerodimentionalElementPassiveCapacitor - Capacitor |
CZeroDimensionalElementPassiveInductor | ZeroDimensionalElementPassiveInductor - Inductor |
►CZeroDimensionalElementPassiveResistor | ZeroDimensionalElementPassiveResistor - Resistor |
CZeroDimensionalElementPassiveDiode | ZerodimentionalElementPassiveDiode - Diode |
►CZeroDimensionalElementSource | ZeroDimensionalElementSource - Base class for source elements |
CZeroDimensionalElementCurrentSource | ZeroDimensionalElementCurrentSource - Current Source |
CZeroDimensionalElementVoltageSource | ZeroDimensionalElementVoltageSource - Voltage Source |
CZeroDimensionalElementS | ZeroDimensionalElementS - Container of elements |
CZeroDimensionalFunction | ZeroDimensionalFunction - A boundary conditions function for zero-dimensional models |
►CZeroDimensionalNode | ZeroDimensionalNode - The base node class |
CZeroDimensionalNodeKnown | ZeroDimensionalNodeKnown - This class defines the known node class. A Voltage Source element is connected to this class |
CZeroDimensionalNodeUnknown | ZeroDimensionalNodeUnknown - This class defines the unknown node class |
CZeroDimensionalNodeS | ZeroDimensionalNodeS - Container of nodes |
CZeroDimensionalSolver | ZeroDimensional Solver |
Cdouble | |
►CExporterPolicy | |
CNavierStokesSolver< Mesh, InitPolicy, TimeIterationPolicy, ExporterPolicy > | |
►CInitPolicy | |
CNavierStokesSolver< Mesh, InitPolicy, TimeIterationPolicy, ExporterPolicy > | |