Class List
Here are the classes, structs, unions and interfaces with brief descriptions:
[detail level 12345]
►Nchrono | Main namespace for the Chrono package |
►Nbt_utils | Utilities for Bullet-based collision detection |
CChConvexHullLibraryWrapper | Wrapper for using and exporting the Bullet implementation of the convex hull library |
►Ncascade | Namespace with classes for the CASCADE module |
CChCascadeBodyEasy | Easy-to-use class for quick creation of rigid bodies with an OpenCASCADE shape |
CChCascadeBodyEasyProfile | Easy-to-use class for quick creation of flat "2D" rigid bodies given a 2D 'wire' profile and a thickness |
►CChCascadeDoc | Class that contains an OCAF document (a tree hierarchy of shapes in the OpenCascade framework) |
CScanShapesCallback | Class to be used as a callback interface for post-processing Cascade shapes |
CChCascadeMeshTools | Tools to convert an OpenCASCADE shapes into triangle meshes |
CChCascadeTriangulate | Class for storing settings on OpenCASCADE tesselation of shapes |
CChVisualShapeCascade | Class for an asset that contains an OpenCASCADE shape which can be included in a visual model |
►Ncopter | Namespace with classes for the Copter models |
CCopter | Base class for any copter, template parameter nop is the number of propellers |
CLittle_Hexy | Little hexy (hexacopter) model |
►Ncuriosity | Namespace with classes for the Curiosity model |
CCuriosity | Curiosity rover class |
CCuriosityBogie | Curiosity rover suspension bogie |
CCuriosityChassis | Curiosity rover Chassis |
CCuriosityDCMotorControl | Concrete Curiosity driver class for a simple DC motor control |
CCuriosityDifferentialBar | Curiosity rover differential bar |
CCuriosityDifferentialLink | Curiosity rover differential link |
CCuriosityDriver | Base class definition for a Curiosity driver |
CCuriosityPart | Base class definition for all Curiosity Rover parts |
CCuriosityRocker | Curiosity rover suspension rocker |
CCuriositySpeedDriver | Concrete Curiosity speed driver |
CCuriosityUpright | Curiosity rover steering upright |
CCuriosityWheel | Curiosity rover Wheel |
►Nfea | Namespace for FEA classes |
CAverageSectionParameters | The aeverage section properties of tapered section could be stored in this struct |
CChBeamMaterialInternalData | Base class for internal variables of materials |
CChBeamSection | Base class for properties of beam sections |
CChBeamSectionCable | Simplified geometry for a 'cable' beam section in 3D, that is a beam without torsional stiffness and with circular section (i.e.same Ixx and Iyy properties) |
CChBeamSectionCosserat | Base class for properties of beam sections of Cosserat type (with shear too) such as ChElementBeamIGA |
CChBeamSectionCosseratEasyCircular | A simple specialization of ChBeamSectionCosserat if you do not need to define its separate models for elasticity, plasticity, damping and inertia |
CChBeamSectionCosseratEasyRectangular | A simple specialization of ChBeamSectionCosserat if you do not need to define its separate models for elasticity, plasticity, damping and inertia |
CChBeamSectionEuler | Base class for all constitutive models of sections of Euler beams |
CChBeamSectionEulerAdvanced | Advanced section of an Euler-Bernoulli beam in 3D, for a homogeneous density and homogeneous elasticity, given basic material properties (Izz and Iyy moments of inertia, area, Young modulus, etc.), but also supporting the advanced case of Iyy and Izz axes rotated respect reference, elastic center with offset from centerline reference, and shear center with offset from centerline reference |
CChBeamSectionEulerAdvancedGeneric | General purpose section of an Euler-Bernoulli beam in 3D, not assuming homogeneous density or homogeneous elasticity, given basic material properties |
CChBeamSectionEulerEasyCircular | A simple specialization of ChBeamSectionEuler if you just need the simplest model for a beam with circular centered section, with uniform elasticity and uniform density |
CChBeamSectionEulerEasyRectangular | A simple specialization of ChBeamSectionEuler if you just need the simplest model for a rectangular centered beam, with uniform elasticity and uniform density |
CChBeamSectionEulerSimple | Basic section of an Euler-Bernoulli beam in 3D, for a homogeneous density and homogeneous elasticity, given basic material properties (Izz and Iyy moments of inertia, area, Young modulus, etc.) |
CChBeamSectionRayleighAdvancedGeneric | This works exactly as ChBeamSectionEulerAdvancedGeneric, but adds the effect of Jyy Jzz rotational sectional inertias |
CChBeamSectionRayleighEasyCircular | This works exactly as ChBeamSectionEulerEasyCircular, but adds the effect of Jyy Jzz rotational sectional inertias |
CChBeamSectionRayleighEasyRectangular | This works exactly as ChBeamSectionEulerEasyRectangular, but adds the effect of Jyy Jzz rotational sectional inertias |
CChBeamSectionRayleighSimple | This works exactly as ChBeamSectionEulerSimple, but adds the effect of Jyy Jzz rotational sectional inertias, whereas the conventional Euler theory would assume the mass to be concentrated in the center of mass, hence Jyy Jzz =0 |
CChBeamSectionShape | Base class for drawing tesselated profiles of beams in 3D views, if needed |
CChBeamSectionShapeCircular | A ready-to-use class for drawing properties of circular beams |
CChBeamSectionShapePolyline | A class for drawing properties of beams whose section is a set of M polylines, each with N points |
CChBeamSectionShapeRectangular | A ready-to-use class for drawing properties of rectangular beams |
CChBeamSectionTaperedTimoshenkoAdvancedGeneric | Base class for all constitutive models of sections of Tapered Timoshenko beams |
CChBeamSectionTaperedTimoshenkoAdvancedGenericFPM | Base class for all constitutive models of fully-populated matrix(FPM) sections of Tapered Timoshenko beams |
CChBeamSectionTimoshenkoAdvancedGeneric | Base class for all constitutive models of sections of Timoshenko beams |
CChBeamSectionTimoshenkoAdvancedGenericFPM | For composite beams such as wind turbine blades and helicopter rotor blades, the cross-sectional stiffness properties in axial, shear, bending and torsion directions are coupled with each other, hence the fully-populated matrix(FPM) of cross-sectional stiffness properties is used to describe this complex coupling |
CChBuilderBeamANCF_3243 | Utility class for creating complex beams using ChElementBeamANCF_3243 elements, for example subdivides a segment in multiple finite elements |
CChBuilderBeamANCF_3333 | Utility class for creating complex beams using ChElementBeamANCF_3333 elements, for example subdivides a segment in multiple finite elements |
CChBuilderBeamEuler | Utility class for creating complex beams using ChElementBeamEuler elements, for example subdivides a segment in multiple finite elements |
CChBuilderBeamIGA | Utility class for creating complex beams using ChElementBeamIGA elements, for example subdivides a segment in multiple finite elements |
CChBuilderBeamTaperedTimoshenko | Utility class for creating complex beams using ChElementBeamTaperedTimoshenko elements, for example subdivides a segment in multiple finite elements |
CChBuilderBeamTaperedTimoshenkoFPM | Utility class for creating complex beams using ChElementBeamTaperedTimoshenkoFPM elements, for example subdivides a segment in multiple finite elements |
CChBuilderCableANCF | Utility class for creating complex beams using ChElementCableANCF elements, for example subdivides a segment in multiple finite elements |
CChContactNodeXYZ | Proxy to FEA nodes, to grant them the features needed for collision detection |
CChContactNodeXYZRot | Proxy to FEA nodes with 3 xyz + 3 rot coords, to grant them the features needed for collision detection |
CChContactNodeXYZRotSphere | Proxy to FEA nodes for collisions, with spheres associated to nodes, for point-cloud type of collisions |
CChContactNodeXYZsphere | Proxy to FEA nodes for collisions, with spheres associated to nodes, for point-cloud type of collisions |
CChContactSegmentXYZ | Contact segment for FEA elements that use XYZ nodes |
CChContactSegmentXYZRot | Contact segment for FEA elements that use XYZRot nodes |
CChContactSurface | Base class for contact surfaces in FEA meshes |
CChContactSurfaceMesh | Class which defines a contact surface for FEA elements, using a mesh of triangles |
CChContactSurfaceNodeCloud | Class which defines a contact surface for FEA elements |
CChContactSurfaceSegmentSet | Class which defines a contact surface for FEA elements |
CChContactTriangleXYZ | Contact element of triangular type |
CChContactTriangleXYZRot | Contact element of triangular type - version for triangles where the nodes are of ChNodeFEAxyzrot type |
CChContinuumDruckerPrager | Class for the basic properties of elastoplastic materials of Drucker-Prager type, that are useful for simulating soils |
CChContinuumElastic | Class for the basic properties of materials in an elastic continuum |
CChContinuumElastoplastic | Class for all elastic materials that can undergo plastic flow |
CChContinuumElectrostatics | Class for material for FEA electrostatic problems |
CChContinuumMaterial | Base class for properties of materials in a continuum |
CChContinuumPlasticVonMises | Class for the basic properties of materials in an elastoplastic continuum, with strain yield limit based on Von Mises yield |
CChContinuumPoisson3D | Class for the basic properties of scalar fields P in 3D FEM problems that can be described by Laplace PDEs of type rho dP/dt + div [C] grad P = 0 |
CChContinuumThermal | Class for thermal fields, for FEA problems involving temperature, heat, etc |
CChDampingCosserat | Base interface for structural damping of beam sections of Cosserat type, where xyz force "n" and xyz torque "m" are a 6-dimensional function of generalized strain speeds, "e'" traction/shear speed and "k'" curvature speed, as: {n,m}=f({e',k'}) Children classes implement this function in different ways |
CChDampingCosseratLinear | Simple linear lumped damping of beam sections of Cosserat type, {n,m}=f({e',k'}) where damping is proportional to speed of deformation/curvature via linear constants: |
CChDampingCosseratRayleigh | Simple Rayleigh damping of beam sections of Cosserat type, where damping is proportional to stiffness via a beta coefficient |
CChDampingKirchhoff | Base interface for damping of thin shells (Kirchoff-Love shell theory, without shear effects) to be used in a ChMaterialShellKirchhoff |
CChDampingKirchhoffRayleigh | Simple Rayleight damping of a Kirchhoff shell layer, where damping is proportional to stiffness via a beta coefficient |
CChDampingReissner | Base interface for damping of 6-field Reissner-Mindlin shells (kinematically-exact shell theory as in Witkowski et al.) to be used in a ChMaterialShellReissner |
CChDampingReissnerRayleigh | Simple Rayleight damping of a Reissner-mindlin shell, where damping is proportional to stiffness via a beta coefficient |
CChElasticityCosserat | Base interface for elasticity of beam sections of Cosserat type, where xyz force "n" and xyz torque "m" are a 6-dimensional function of generalized strains, "e" traction/shear and "k" curvatures, as: {n,m}=f({e,k}) There are various children classes that implement this function in different ways |
CChElasticityCosseratAdvanced | Advanced linear elasticity for a Cosserat beam |
CChElasticityCosseratAdvancedGeneric | Advanced linear elasticity for a Cosserat section, not assuming homogeneous elasticity |
CChElasticityCosseratAdvancedGenericFPM | A Cosserat section which allows to input the material fully-populated stiffness matrix(FPM) of cross-section directly |
CChElasticityCosseratGeneric | Generic linear elasticity for a Cosserat beam using directly a 6x6 matrix [E] as user-input data |
CChElasticityCosseratMesh | Elasticity for a beam section in 3D, where the section is defined by a mesh of triangles |
CChElasticityCosseratSimple | Simple linear elasticity model for a Cosserat beam, using basic material properties (zz and yy moments of inertia, area, Young modulus, etc.) |
CChElasticityKirchhoff | Base interface for elasticity of thin shells (Kirchoff-Love shell theory, without shear effects) to be used in a ChMaterialShellKirchhoff |
CChElasticityKirchhoffGeneric | Generic linear elasticity for thin shells (Kirchoff-Love shell theory, without shear effects) to be used in a ChMaterialShellKirchhoff |
CChElasticityKirchhoffIsothropic | Isothropic elasticity for thin shells (Kirchoff-Love shell theory, without shear effects) to be used in a ChMaterialShellKirchhoff |
CChElasticityKirchhoffOrthotropic | Orthotropic elasticity for thin shells (Kirchoff-Love shell theory, without shear effects) to be used in a ChMaterialShellKirchhoff |
CChElasticityReissner | Base interface for elasticity of 6-field Reissner-Mindlin shells (kinematically-exact shell theory as in Witkowski et al.) to be used in a ChMaterialShellReissner |
CChElasticityReissnerGeneric | Generic linear elasticity for 6-field Reissner-Mindlin shells (kinematically-exact shell theory as in Witkowski et al.) to be used in a ChMaterialShellReissner |
CChElasticityReissnerIsothropic | Elasticity of 6-field Reissner-Mindlin shells (kinematically-exact shell theory as in Witkowski et al.) to be used in a ChMaterialShellReissner |
CChElasticityReissnerOrthotropic | Elasticity of 6-field Reissner-Mindlin shells (kinematically-exact shell theory as in Witkowski et al.) to be used in a ChMaterialShellReissner |
CChElementANCF | Base class for ANCF elements |
CChElementBar | Simple finite element with two nodes and a bar that connects them |
CChElementBase | Base class for all finite elements, that can be used in the ChMesh physics item |
CChElementBeam | Base class for most structural elements of 'beam' type |
CChElementBeamANCF_3243 | ANCF beam element with two nodes |
CChElementBeamANCF_3333 | ANCF beam element with three nodes |
CChElementBeamEuler | Simple beam element with two nodes and Euler-Bernoulli formulation |
CChElementBeamIGA | Isogeometric formulation (IGA) of a Cosserat rod, with large displacements, based on the Geometrically Exact Beam Theory |
CChElementBeamTaperedTimoshenko | Classical Timoshenko beam element with two nodes, and tapered sections |
CChElementBeamTaperedTimoshenkoFPM | For composite beams such as wind turbine blades and helicopter rotor blades, the cross-sectional stiffness properties in axial, shear, bending and torsion directions are coupled with each other, hence the fully-populated matrix(FPM) of cross-sectional stiffness properties is used to describe this complex coupling |
CChElementCableANCF | Simple beam element with two nodes and ANCF gradient-deficient formulation |
CChElementCorotational | Class for corotational elements (elements with rotation matrices that follow the global motion of the element) |
CChElementGeneric | Class for all elements whose stiffness matrix can be seen as an NxN block-matrix split among N nodes |
CChElementHexaANCF_3813 | Hexahedronal solid element with 8 nodes (with EAS) |
CChElementHexaANCF_3813_9 | Hexahedronal solid element with 8 nodes and a central curvature node |
CChElementHexaANCF_3843 | ANCF brick element with eight nodes |
CChElementHexaCorot_20 | Class for FEA elements of hexahedron type (isoparametric 3D bricks) with 20 nodes |
CChElementHexaCorot_8 | Class for FEA elements of hexahedron type (isoparametric 3D bricks) with 8 nodes |
CChElementHexahedron | Base class for a FEA element with hexahedral shape |
CChElementShell | Base class for most structural elements of 'shell' type |
►CChElementShellANCF_3423 | ANCF laminated shell element with four nodes |
CLayer | Definition of a layer |
►CChElementShellANCF_3443 | ANCF shell element with four nodes |
CLayer | Definition of a layer |
►CChElementShellANCF_3833 | ANCF shell element with four nodes |
CLayer | Definition of a layer |
►CChElementShellBST | A Kirchhoff-Love thin shell element of triangular shape |
CLayer | Definition of a layer |
►CChElementShellReissner4 | Laminated thick shell with geometrically exact kinematics, with 4 nodes |
CLayer | Definition of a layer |
CChElementSpring | Simple finite element with two nodes and a spring/damper between the two nodes |
CChElementTetraCorot_10 | Tetrahedron FEA element with 10 nodes |
CChElementTetraCorot_4 | Tetrahedron FEA element with 4 nodes |
CChElementTetraCorot_4_P | Tetrahedron FEM element with 4 nodes for scalar fields (for Poisson-like problems) |
CChElementTetrahedron | Base class for a FEA element with tetrahedral shape |
CChExtruderBeamEuler | Class for an object that continuously extrude a beam (composed of ChElementBeamEuler elements) with prescribed velocity |
CChExtruderBeamIGA | Class for an object that continuously extrude a beam (composed of ChElementBeamIGA elements) with prescribed velocity |
CChGaussIntegrationRule | Class for the management of the Gauss Quadrature in 1D, 2D or 3D space |
CChGaussPoint | Class for a Gauss point, that has a position (1D-3D) and a weight |
CChHexahedronFace | Face of a hexahedron-shaped element |
CChInertiaCosserat | Base class for inertial properties (mass, moment of inertia) of beam sections of Cosserat type |
CChInertiaCosseratAdvanced | Inertia properties of a beam of Cosserat type, not necessarily of uniform density, from the following information that allows the center of mass to be offset respect to the beam centerline: |
CChInertiaCosseratMassref | Inertia properties of a beam of Cosserat type, not necessarily of uniform density, from the following information that allows the center of mass to be offset respect to the beam centerline: |
CChInertiaCosseratSimple | Inertia properties of a beam of Cosserat type, defined from an uniform density [kg/m^3], and the following geometric information: |
CChInternalDataLumpedCosserat | Internal variables for basic lumped plasticity in Cosserat beams |
CChLinkBeamIGAFrame | Constraint that allows an IGA beam to slide relative to a ChBodyFrame |
CChLinkNodeFace | Constraint between an xyz FEA node (point) and a triangular face given by three xyz FEA nodes The triangular face element is assumed to have linear shape function (e.g., the face of a tetrahedron or a triangular shell) |
CChLinkNodeFaceRot | Constraint between an xyz FEA node (point) and a triangular face given by three xyzrot FEA nodes |
CChLinkNodeFrame | Constraint between an FEA node of ChNodeFEAxyz type and a ChBodyFrame (frame) object |
CChLinkNodeFrameGeneric | Constraint between an FEA node of ChNodeFEAxyz type and a ChBodyFrame (frame) object |
CChLinkNodeNode | Constraint between two xyz FEA nodes (points) |
CChLinkNodeSlopeFrame | Constraint between the direction of a FEA node of ChNodeFEAxyzD class, and a ChBodyFrame (frame) |
CChLoadBeamWrench | Atomic wrench (ready to use load) Load for a wrench (force+torque) at a specific position of a beam |
CChLoadBeamWrenchDistributed | Distributed constant wrench (ready to use load) Load for a wrench (force+torque) at a specific position of a beam |
CChLoadContactSurfaceMesh | Class for applying loads to a contact mesh as a cluster of forces on the nodes of the underlying finite elements |
CChLoaderBeamWrench | Atomic wrench |
CChLoaderBeamWrenchDistributed | Distributed constant wrench |
CChLoadNodeXYZRot | Base class for loads representing a concentrated wrench (force + torque) acting on a ChNodeFEAxyzrot |
CChLoadNodeXYZRotBody | Base class for loads representing a concentrated wrench (force & torque) acting between a ChNodeFEAxyzrot and a ChBody The force & torque is applied between two local references attached to the two nodes, loc_application_A and loc_application_B, not necessarily centered in the respective nodes |
CChLoadNodeXYZRotBodyBushingGeneric | Load for a visco-elastic translational/rotational bushing acting between a ChNodeFEAxyzrot and a ChBody |
CChLoadNodeXYZRotBodyBushingMate | Load for a visco-elastic translational/rotational bushing acting between a ChNodeFEAxyzrot and a ChBody |
CChLoadNodeXYZRotBodyBushingPlastic | Load for a visco-elasto-plastic bushing acting between a ChNodeFEAxyzrot and a ChBody |
CChLoadNodeXYZRotBodyBushingSpherical | Load for a visco-elastic bushing acting between a ChNodeFEAxyzrot and a ChBody |
CChLoadNodeXYZRotForceAbs | Load representing a concentrated force acting on a ChNodeFEAxyzrot |
CChLoadNodeXYZRotNodeXYZRot | Base class for loads representing a concentrated wrench (force & torque) acting between two ChNodeFEAxyzrot |
CChLoadNodeXYZRotNodeXYZRotBushingGeneric | Load for a visco-elastic translational/rotational bushing acting between two bodies |
CChLoadNodeXYZRotNodeXYZRotBushingMate | Load for a visco-elastic translational/rotational bushing acting between two ChNodeFEAxyzrot nodes |
CChLoadNodeXYZRotNodeXYZRotBushingPlastic | Load for a visco-elasto-plastic bushing acting between two ChNodeFEAxyzrot |
CChLoadNodeXYZRotNodeXYZRotBushingSpherical | Load for a visco-elastic bushing acting between two bodies |
CChMaterialBeamANCF | Definition of materials to be used for ANCF beams utilizing the Enhanced Continuum Mechanics based method |
CChMaterialHexaANCF | Definition of materials to be used for ANCF brick elements |
CChMaterialShellANCF | Definition of materials to be used for ANCF shells |
CChMaterialShellKirchhoff | Material for a single layer of a thin shell (Kirchoff-Love shell theory, i.e |
CChMaterialShellReissner | Material for a single layer of a 6-field Reissner-Mindlin shells (kinematically-exact shell theory as in Witkowski et al) |
CChMaterialShellReissnerIsothropic | For backward compatibility only! New approach: create a ChElasticityReissnerOrthotropic and create a ChMaterialShellReissner by passing the elasticity as a parameter |
CChMaterialShellReissnerOrthotropic | For backward compatibility only! New approach: create a ChElasticityReissnerOrthotropic and create a ChMaterialShellReissner by passing the elasticity as a parameter |
CChMatrixCorotation | Perform a corotation (warping) of a K matrix by pre- or post- multiplying it with a C matrix that has 3x3 rotation matrices R as diagonal blocks, so that C*K means: |
CChMesh | Class which defines a mesh of finite elements of class ChElementBase using nodes of class ChNodeFEAbase |
CChMeshExporter | Collection of mesh file writer utilities |
CChMeshFileLoader | Collection of mesh file loader utilities |
CChMeshSurface | Class which defines a surface for a mesh FEA elements |
CChNodeFEAbase | Base class for a generic finite element node that can be stored in ChMesh containers |
CChNodeFEAcurv | Generic finite element node with 9 degrees of freedom representing curvature |
CChNodeFEAxyz | Class for a generic 3D finite element node, with x,y,z displacement |
CChNodeFEAxyzD | Class for a generic 3D finite element node, with x,y,z displacement and a direction |
CChNodeFEAxyzDD | Class for a generic 3D finite element node, with x,y,z displacement and 2 position vector derivatives |
CChNodeFEAxyzDDD | Class for a generic 3D finite element node, with x,y,z displacement, and 3 position vector derivatives |
CChNodeFEAxyzP | Class for a generic finite element node in 3D space, with scalar field P |
CChNodeFEAxyzrot | Class for a generic ED finite element node, with x,y,z displacement and a 3D rotation |
CChPlasticityCosserat | Base class for plasticity of beam sections of Cosserat type |
CChPlasticityCosseratLumped | Lumped plasticity of Cosserat-type beams |
CChPlasticityKirchhoff | Base interface for plasticity of thin shells (Kirchoff-Love shell theory, without shear effects) to be used in a ChMaterialShellKirchhoff |
CChPlasticityReissner | Base interface for plasticity of 6-field Reissner-Mindlin shells (kinematically-exact shell theory as in Witkowski et al.) to be used in a ChMaterialShellReissner |
CChPolarDecomposition | Perform a polar decomposition of a 3x3 P matrix in order to retrieve the orthogonal Q and the symmetric S form, as P=Q*S |
CChShellKirchhoffInternalData | Base class for internal variables of Kirchhoff thin shells materials |
CChShellReissnerInternalData | Base class for internal variables of Reissner shells materials |
CChTetrahedronFace | Face of a tetrahedron-shaped element |
CChTriangleNodesXYZ | Utility class for using the ChLinkNodeFace constraint |
CChTriangleNodesXYZrot | Utility class for using the ChLinkNodeFaceRot constraint |
CDampingCoefficients | This damping model supports you to assign different Rayleigh damping coefficients for different dimensions, which would be helpful for those anisotropic material, such as wind turbine blade |
CPolarDecomposition | Polar decomposition of a general 3x3 matrix |
►Nfmi2 | Namespace with classes for the FMI module (FMI 2.0 support) |
CChOutputFMU | Class for serializing variables to FmuComponentBase |
CFmuChronoComponentBase | Extension of FmuComponentBase class for Chrono FMUs |
CFmuChronoUnit | Extension of FmuUnit class for Chrono FMUs |
►Nfmi3 | Namespace with classes for the FMI module (FMI 3.0 support) |
CFmuChronoComponentBase | Extension of FmuComponentBase class for Chrono FMUs |
CFmuChronoUnit | Extension of FmuUnit class for Chrono FMUs |
►Nfsi | Namespace with classes for the FSI module |
CChBce | Base class for processing boundary condition enforcing (BCE) particle forces in an FSI system |
CChCollisionSystemFsi | Base class for processing proximity computation in an FSI system |
CChCounters | Number of rigid and flexible solid bodies, fluid SPH particles, solid SPH particles, boundary SPH particles |
CChFluidDynamics | Class to represent the fluid/granular dynamics system |
CChFsiBase | Base class for various FSI classes |
CChFsiForce | Base class to calculate force between SPH particles |
CChFsiForceExplicitSPH | Inter-particle force calculation for explicit schemes |
CChFsiForceI2SPH | Inter-particle force calculation for the I2SPH method |
CChFsiInterface | Base class for processing the interface between Chrono and FSI modules |
CChFsiLinearSolver | Base class for solving linear systems on GPUs |
CChFsiLinearSolverBiCGStab | BiCG-Stab iterative linear solver |
CChFsiLinearSolverGMRES | GMRES iterative linear solver |
►CChFsiProblem | Base class to set up a Chrono::FSI problem |
CCoordHash | Hash function for a 3D integer grid coordinate |
CParticlePropertiesCallback | Interface for callback to set initial particle pressure, density, viscosity, and velocity |
CRigidBody | Specification of an FSI rigid body |
CChFsiProblemCartesian | Class to set up a Chrono::FSI problem using particles and markers on a Cartesian coordinates grid |
CChFsiProblemCylindrical | Class to set up a Chrono::FSI problem using particles and markers on a cylindrical coordinates grid |
CChFsiVisualization | Run-time visualization support for Chrono::FSI systems |
CChFsiVisualizationGL | Run-time visualization support for Chrono::FSI systems |
CChFsiVisualizationVSG | Run-time visualization support for Chrono::FSI systems |
►CChSystemFsi | Physical system for fluid-solid interaction problems |
CElasticMaterialProperties | Structure with elastic material properties |
CFluidProperties | Structure with fluid properties |
CLinSolverParameters | Structure with linear solver parameters (used only for implicit SPH) |
CSPHParameters | Structure with SPH method parameters |
CChSystemFsi_impl | Underlying implementation of an FSI system |
CChUtilsDevice | Utilities for thrust device vectors |
CDepthPressurePropertiesCallback | Predefined SPH particle initial properties callback (depth-based pressure) |
CFsiBodyStateD | Rigid body states on device |
CFsiBodyStateH | Rigid body states on host |
CFsiData | FSI system information information exchanged with the Chrono system |
CFsiMeshStateD | FEA mesh state on device |
CFsiMeshStateH | FEA mesh states on host |
CGpuTimer | Time recorder for cuda events |
CProximityDataD | Struct to store neighbor search information on the device |
CSimParams | Structure with FSI simulation parameters |
CSphMarkerDataD | Struct to store the information of SPH particles on the device |
CSphMarkerDataH | Struct to store the information of SPH particles on the host |
►Ngpu | Namespace with classes for the Gpu module |
CBC_params_t | Big enum to handle all possible boundary conditions |
CChGpuSimulationParameters | Structure with Chrono::Gpu simulation parameters |
CChGpuVisualization | Run-time visualization support for Chrono::Gpu systems |
CChSolverStateData | ChSolverStateData contains information that pertains the solver, at a certain point in time |
CChSystemGpu | Interface to a Chrono::Gpu system |
CChSystemGpuMesh | Interface to a Chrono::Gpu mesh system |
CPlane_BC_params_t | Infinite Plane defined by point in plane and normal |
CPlate_BC_params_t | Customized finite Plate defined by center of the plate, normal and y dim |
CSphere_BC_params_t | Sphere |
CZ_Cone_BC_params_t | Z-aligned cone pointed downward |
CZ_Cylinder_BC_params_t | Infinite Z-aligned cylinder |
►Nirrlicht | Namespace with classes for the Irrlicht module |
CChIrrGUI | Irrlicht GUI attached to a ChVisualSystemIrrlicht |
CChIrrNodeModel | Irrlicht scene node associated with the visual model of a physics item |
CChIrrNodeShape | Irrlicht scene node associated with a visual shape in a visual model |
►CChVisualSystemIrrlicht | Irrlicht-based Chrono run-time visualization system |
CChIrrNodeVisual | Irrlicht scene node for a visual model not associated with a physics item |
CCScreenQuad | CScreenQuad |
CCShaderPreprocessor | CShaderPreprocessor |
CDepthShaderCB | DepthShaderCB |
CEffectHandler | Main effect handling class, use this to apply shadows and effects |
CRTSCamera | Class to create an interactive videocamera in Irrlicht, that is similar to the Maya camera but hasn't the problems that the Maya camera has in Irrlicht 1.5 |
CScreenQuadCB | ScreenQuadCB |
CShadowShaderCB | ShadowShaderCB |
►Nmodal | Namespace with classes for the modal module |
Ccallback_Ax | Generic A*x callback |
Ccallback_Ax_sparse_complexshiftinvert | The callback to be used for "A*x" where for shift&invert is: A = (As - sigma Bs)/Bs , with COMPLEX sigma shift, so A*x = (As - sigma Bs)/(Bs*x), just like a linear system with coefficient matrix (As - sigma Bs) and known rhs Bs*x |
Ccallback_Ax_sparse_shiftinvert | The callback to be used for "A*x" where for shift&invert is: A = (As - sigma Bs)/Bs , so A*x = (As - sigma Bs)/(Bs*x), just like a linear system with coefficient matrix (As - sigma Bs) and known rhs Bs*x |
CChGeneralizedEigenvalueSolver | Base interface class for generalized eigenvalue solvers A*x = lambda*B*x |
CChKrylovSchurEig | Compute (complex) eigenvalues and eigenvectors using the Krylov-Schur algorithm |
CChModalAssembly | Class for assemblies of items, for example ChBody, ChLink, ChMesh, etc |
CChModalDamping | Base class for damping models of modal reduced assemblies |
CChModalDampingCustom | Class for damping defined with an user-defined matrix that could be obtained via external tools such as Matlab or FEA |
CChModalDampingFactorAssembly | Class for setting the damping via N damping factors z_i for all the modes of the subassembly, where assembly n.modes = (boundary coords+internal modes) R^ = V'^-1 * Dd * V^-1 with Dd=diag { 2 z_1 w_1, 2 z_2 w_2, ..., 2 z_i w_i }, and V = eigenvectors of (M^, K^) |
CChModalDampingFactorRayleigh | Class for setting the damping via N damping factors z_i of the internal mode coordinates and alpha-beta Rayleigh damping for the boundary nodes, assuming R^ = [Rbb Rbm ] [Rmb Rmm ] with Rmm=diag { 2 z_1 w_1, 2 z_2 w_2, ..., 2 z_i w_i }, Rbb= alpha*Mbb + beta*Kbb, Rbm = 0, Rmb = 0 |
CChModalDampingFactorRmm | Class for setting the damping via N damping factors z_i of the internal mode coordinates |
CChModalDampingNone | Class for no damping model |
CChModalDampingRayleigh | Class for simple Rayleigh damping model R^ = alpha*M^ + beta*K^ where M^ and K^ are the reduced matrices, both for boundary nodes and modal coords |
CChModalDampingReductionR | Class for damping as reduction of the original damping matrix via the eigenvectors of the undamped assembly, i.e |
CChModalEventReceiver | Custom Irrlicht event receiver for modal analysis visualization |
CChModalSolver | Base class for modal solvers |
CChModalSolverDamped | Modal solver for damped systems of the form (-w^2*M + i*w*R + K)*x = 0 s.t |
CChModalSolverUndamped | Modal solver for undamped systems (-w^2*M+K)*x = 0 s.t |
CChModalVisualSystemIrrlicht | Customized Chrono Irrlicht visualization for modal analaysis |
CChSymGenEigenvalueSolver | Base interface class for iterative eigenvalue solvers for generalized problem with real symmetric matrices |
CChSymGenEigenvalueSolverKrylovSchur | Generalized iterative eigenvalue solver implementing Krylov-Schur shift-and-invert method for real symmetric matrices |
CChSymGenEigenvalueSolverLanczos | Generalized iterative eigenvalue solver implementing Lanczos shift-and-invert method for real symmetric matrices |
CChUnsymGenEigenvalueSolver | Base interface class for iterative eigenvalue solvers for generalized problem with real generic matrices |
CChUnsymGenEigenvalueSolverKrylovSchur | Generalized iterative eigenvalue solver implementing Krylov-Schur shift-and-invert method for real generic matrices |
►Nopengl | Namespace with classes for the OpenGL module |
CChOpenGLBars | Renders rectangular bars |
CChOpenGLBase | Base class for all OpenGL related classes |
CChOpenGLCamera | OpenGL camera class |
CChOpenGLCloud | Generic renderable point cloud |
CChOpenGLContacts | Renders contact points as a point cloud |
CChOpenGLEventCB | Interface of an object which can receive events |
CChOpenGLGraphs | Class to render simple plots for the UI |
CChOpenGLMesh | Generic renderable triangle mesh |
CChOpenGLOBJ | Class for rendering an object |
CChOpenGLObject | Base class for all drawable objects |
CChOpenGLOBJLoader | Uses the tiny_obj_loader library to load an OBJ file in the proper format |
CChOpenGLParticleCB | Base class for a particle rendering discriminator |
CChOpenGLShader | Sample shader class that loads and compiles the vertex and fragment shaders |
►CChOpenGLStats | Base class for an OpenGL stats overlay |
CScreen | Screen coordinates for text placement |
CChOpenGLStatsDefault | Class that renders the text and other UI elements |
CChOpenGLText | Generic renderable text class that uses an atlas stored in the FontData.h file |
CChOpenGLVertexAttributesPADSN | Support for ADS lighting with glow |
CChOpenGLVertexAttributesPADSNT | Support for ADS lighting with glow and texture coordinates |
CChOpenGLViewer | OpenGL viewer, this class draws the system to the screen and handles input |
CChOpenGLWires | Renders a wireframe view for triangles |
CChVisualSystemOpenGL | OpenGL-based Chrono run-time visualization system |
►Nparsers | Namespace with classes for the Parsers module |
►CChParserAdams | ADAMS input file parser |
►CReport | Report containing information about objects parsed from file |
CJointInfo | Information about a joint read in from ADAMS |
►CChParserOpenSim | OpenSim input file parser |
►CReport | Report containing information about objects parsed from file |
CForceInfo | Information about a custom load created from OpenSim |
CJointInfo | Information about a joint read in from OpenSim |
►CChParserURDF | URDF input file parser |
CCustomProcessor | Class to be used as a callback interface for custom processing of the URDF XML string |
CChPythonEngine | Class for a Python parser |
►CChRobotActuation | Generic robot actuation driver using interpolated data from files |
CPhaseChangeCallback | Class to be used as callback interface for user-defined actions at phase changes |
►Nparticlefactory | Namespace for classes that generate flows of particles |
CChParticleEmitter | Class for emitters of particles, with random positions, rotations, and random shapes |
CChParticleEventFlowInRectangle | Trigger an event each time a particle flows into a rectangle |
CChParticleEventTrigger | BASE class for event triggers for the ChParticleProcessor You can directly use the ready-to-use triggers for common triggering (particle collides with some object, particle inside a box, etc.), or inherit your own class with custom triggering |
CChParticleEventTriggerBox | Event trigger for particles inside a box volume |
CChParticleEventTriggerNever | Simplest case: never trigger |
CChParticleProcessEvent | BASE class for all event processors of single particles You can directly use the ready-to-use processor for basic behaviors (remove particle, count particle, etc.), or inherit your own class with custom event processing |
CChParticleProcessEventCount | Processed particle will be counted |
CChParticleProcessEventDoNothing | Simplest case: no event processing Just an example |
CChParticleProcessEventMassCount | Processed particle will increment a mass counter |
CChParticleProcessEventMassDistribution | Processed particle will increment a NxM matrix mass counter, so that a statistical distribution of flow over a uv surface can be obtained |
CChParticleProcessEventRemove | Processed particle will be removed |
CChParticleProcessor | Class that can be used to process particles |
CChParticleRemoverBox | Utility class: shortcut for creating a ChParticleProcessor that already contains a ChParticleEventTriggerBox and a ChParticleProcessEventRemove |
CChRandomParticleAlignment | BASE class for generators of random particle alignment |
CChRandomParticleAlignmentUniform | Class for generator of random particle alignment |
CChRandomParticlePosition | BASE class for generators of random particle positions |
CChRandomParticlePositionOnGeometry | Class for generator of random particle positions scattered over a parametric surface |
CChRandomParticlePositionRectangleOutlet | Class for generator of random particle positions scattered over a rectangle outlet in 3D space |
CChRandomParticleVelocity | BASE class for generators of random particle velocities |
CChRandomParticleVelocityAnyDirection | Generator of random particle velocities with any direction |
CChRandomParticleVelocityConstantDirection | Generator of random particle velocities with constant direction |
►CChRandomShapeCreator | BASE class for generators of random ChBody shapes |
CAddBodyCallback | Class to be used as a callback interface for some user-defined action to be taken each time a body is generated and added to the system |
CChRandomShapeCreatorBoxes | Class for generating boxes with variable sizes and density |
CChRandomShapeCreatorConvexHulls | Class for generating convex hulls with variable chordal size and aspect ratios |
CChRandomShapeCreatorCylinders | Class for generating cylinders with variable diameter and length |
CChRandomShapeCreatorFromFamilies | Class for generating spheres from different families, each with given probability |
CChRandomShapeCreatorShavings | Class for generating worm-like particles, optionally helically twisted |
CChRandomShapeCreatorSpheres | Class for generating spheres with variable radius and density |
►Npostprocess | Namespace with classes for the POSTPROCESS module |
CChBlender | Class for post processing implementation that generates scripts for Blender |
CChGnuPlot | Class for plotting data with GNUplot |
CChPostProcessBase | Base class for post processing implementations |
CChPovRay | Class for post processing implementation that generates scripts for POVray |
►Nrobosimian | Namespace with classes for the RoboSimian model |
CLink | RoboSimian link |
CRoboSimian | RoboSimian robot model |
CRoboSimianVisualSystemIrrlicht | Customized Chrono Irrlicht visualization system for RoboSimian |
CRS_Chassis | RoboSimian chassis (torso) |
►CRS_Driver | Driver for the RoboSimian robot |
CPhaseChangeCallback | Class to be used as callback interface for user-defined actions at phase changes |
CRS_DriverCallback | Robot driver callback to keep track of average speed and distance between phase changes |
CRS_Limb | RoboSimian limb |
CRS_Part | RoboSimian part |
CRS_Sled | RoboSimian sled (attached to chassis) |
CRS_WheelDD | RoboSimian direct-drive wheel |
►Nros | Namespace for Chrono::ROS |
CChROSAccelerometerHandler | This handler is responsible for interfacing a ChAccelerometerSensor to ROS. Will publish sensor_msgs::msg::Imu |
CChROSBodyHandler | This handler is responsible for publishing state information about a ChBody |
CChROSCameraHandler | This handler is responsible for interfacing a ChCameraSensor to ROS. Will publish sensor_msgs::msg::Image |
CChROSClockHandler | Publishes rosgraph_msgs::msg::Clock messages at each timestep (by default) of the simulation |
CChROSDriverInputsHandler | This handler is responsible for interfacing a ChDriver to ROS |
CChROSGPSHandler | This handler is responsible for interfacing a ChGPSSensor to ROS. Will publish sensor_msgs::msg::NavSatFix |
CChROSGyroscopeHandler | This handler is responsible for interfacing a ChGyroscopeSensor to ROS. Will publish sensor_msgs::msg::Imu |
CChROSHandler | Base class for a ROS handler |
CChROSHandlerUtilities | Utility class with static functions that may be useful for ROS handlers |
CChROSInterface | This class handles the API interface between Chrono and ROS |
CChROSLidarHandler | This handler interfaces a ChLidarSensor to ROS |
CChROSMagnetometerHandler | This handler is responsible for interfacing a ChMagnetometerSensor to ROS |
CChROSManager | Managers the ROS handlers and their registration/updates |
CChROSRobotModelHandler | This handler is responsible for publishing a robot model to be visualized in RViz RViz expects a string containing the robot model |
CChROSSensorHandlerUtilities | Utility class with static functions that may be useful for sensor-specific ROS handlers |
CChROSTFHandler | This handler is responsible for publishing transform (tf) information |
CChROSViperDCMotorControlHandler | This handler is responsible for interfacing a ViperDCMotorControl driver to ROS |
►Nsensor | Namespace for Chrono::Sensor |
CAccelData | Accelerometer data |
CBackground | Information about the background of the scene |
CByteImageData | Stores image data |
CChAccelerometerSensor | Accelerometer class |
CChCameraSensor | Camera class |
CChDepthCamera | Camera class |
CChDynamicsManager | Class for managing dynamic sensors |
CChFilter | Base class for all filters that can be applied to a sensor after initial rendering |
CChFilterAccelerometerUpdate | Class for generating IMU data |
CChFilterAccess | Filter for accessing data from the sensor |
CChFilterCameraNoiseConstNormal | A filter that adds Gaussian noise across an image with constant mean and standard deviation |
CChFilterCameraNoisePixDep | A filter that adds pixel dependent gaussian noise across an image. Method summarized in paper: () |
CChFilterDepthToRGBA8 | A filter that converts Depth values to RGBA8 |
CChFilterGPSUpdate | Class for generating GPS data for a GPS sensor |
CChFilterGrayscale | A filter that, when applied to a sensor, changes the RGB buffer to grayscale |
CChFilterGyroscopeUpdate | Class for generating IMU data |
CChFilterImageHalf4ToRGBA8 | A filter that converts RGBA Float4 to RGBA8 |
CChFilterImageResize | A filter that, when applied to a sensor, resizes the image to the specified dimensions |
CChFilterImgAlias | A filter that, when applied to a sensor, reduces the resolution for antialiasing |
CChFilterLidarNoiseXYZI | A filter that adds noise based on depth and intensity given data in point cloud format |
CChFilterMagnetometerUpdate | Class for generating IMU data |
CChFilterONNX | A filter that processes data through a pre-trained neural network, based on ONNX format |
CChFilterOptixRender | A filter that generates data for a ChOptixSensor |
CChFilterPCfromDepth | A filter that, when applied to a sensor, generates point cloud data from depth values |
CChFilterRadarProcess | A filter that, when applied to a sensor, converts the depth values to pointcloud, clusters, and calculates velocity and centroid |
CChFilterRadarSavePC | A filter that, when applied to a sensor, saves point cloud data |
CChFilterSave | A filter that, when applied to a sensor, saves the data as an image |
CChFilterSavePtCloud | A filter that, when applied to a sensor, saves point cloud data |
CChFilterUFF | A filter that processes data through a pre-trained neural network, based on UFF format |
CChFilterVisualize | A filter that, when applied to a sensor, creates a GUI window to visualize the sensor (using GLFW) |
CChFilterVisualizePointCloud | A filter that, when applied to a sensor, creates a GUI window to visualize the sensor (using GLFW) |
CChGPSSensor | GPS class |
CChGyroscopeSensor | Gyroscope class |
CChLidarSensor | Lidar class. This corresponds to a scanning lidar |
CChMagnetometerSensor | Magnetometer class |
CChNoiseModel | Noise model base class |
CChNoiseNone | Noise model: no noise |
CChNoiseNormalDrift | IMU Noise model: gaussian drifting noise with noncorrelated equal distributions |
CChNoiseRandomWalks | GPS Noise model based on Random Walks |
CChOptixEngine | Optix Engine that is responsible for managing all render-based sensors |
CChOptixGeometry | Optix Geometry class that is responsible for managing all geometric information in the optix scene This handles the acceleration structure and transforms |
CChOptixPipeline | Class to hold all the Shader Binding Table parameters adnd manage the ray tracing pipeline, materials, ray gen programs |
CChOptixSensor | Optix sensor class - the base class for all sensors that interface with OptiX to generate and render their data |
CChRadarSensor | Radar Class/ This corresponds to a fmcw radar |
CChScene | Scene class used for camera renderings. Includes environment colors, lights, etc |
CChSegmentationCamera | Camera class |
CChSensor | Base class for a chrono sensor. A specific sensor can inherit from here |
CChSensorManager | Class for managing sensors. This is the Sensor system class |
CChTachometerSensor | Tachometer class. This class queries the chrono system for the angular velocity of the parent body |
CGPSData | GPS data in generic format |
CGyroData | Gyroscope data |
CLogger | Inference Logger for TensorRT |
CMagnetData | Magnetometer data |
CPixelDI | Depth and intensity data in generic format |
CPixelFloat4 | A pixel as defined by RGBA float4 format |
CPixelHalf4 | A pixel as defined by RGBA float4 format |
CPixelRGBA8 | A pixel as defined by RGBA 8bpp format |
CPixelSemantic | A pixel as defined for semantic segmentation |
CPixelXYZI | Point cloud and intensity data in generic format |
CProgramString | Holds string values for ptx file and ray generation program |
CSensor | Sensor class for constructing sensors from a JSON specification file |
CSensorBuffer | The base buffer class that contains sensor data (contains meta data of the buffer and pointer to raw data) |
CSensorBufferT | Base class of 2D buffers |
CTransform | Transform struct for packing a translation, rotation, and scale |
CTRTDestroyer | Destructor for tensorRT pointers |
►Nsynchrono | Namespace for SynChrono |
CApproachLane | Lane that is grouped into an approach with other ApproachLanes |
CChMultiPathFollowerACCDriver | A driver model that is very similar with ChPathFollowerACCDriver but it uses multiple path steering controllers |
CChMultiplePathSteeringController | Concrete path-following steering PID controller with multiple path support |
CGPScoord | Wrapper class around vector stores GPS points as (lat, long, alt) in degrees |
CIntersection | Contains some number of approaches - see ApproachMessage |
CIntersectionLane | Lane for the purpose of SPAT messages (i.e. something that can have its light color change) |
CSCMParameters | Groups SCM parameters into a struct, defines some useful defaults See SCMTerrain::SetSoilParameters and SoilParametersCallback for more details on these |
CSynAgent | Base class for SynChrono agents |
CSynAgentFactory | Generates SynTerrain's from JSON files Used to improve generality in Agent classes |
CSynApproachMessage | Approach message |
CSynChronoManager | Base class responsible for handling agents and synchronizing states between nodes |
CSynCommunicator | Base class communicator used to establish and facilitate communication between nodes |
CSynCopterAgent | Agent wrapper of a copter model, sends out SynCopterMessage-s to synchronize its state |
CSynCopterDescriptionMessage | Description class that holds description information for a SynCopter |
CSynCopterStateMessage | State class that holds state information for a SynCopter |
CSynDDSCommunicator | Derived communicator used to establish and facilitate communication between nodes |
CSynDDSDataReaderListener | Data reader listener that can both count publishers on a topic and can be used as an asynchronous listener |
CSynDDSDataWriterListener | Data writer listener that counts number of subscribers listening to a specific topic |
CSynDDSParticipantListener | Participant listener that will count the number of participants and store their names to be used later |
CSynDDSPublisher | DDS publisher wrapper. Sends information on a topic |
CSynDDSSubscriber | DDS subscriber wrapper. Listens for information on a topic |
CSynDDSThreadSafeCounter | Thread safe counter used to count various elements Use case would be to block until a certain number of elements |
CSynDDSTopic | Describes information that's being distributed over an abstract "wire" Includes data type and meta information (i.e |
►CSynEnvironmentAgent | Derived agent class. Acts as a traffic light and distributes MAP and/or SPAT data |
CLaneData | It defines the traffic light color and schedule for one lane |
CSynEnvironmentMessage | The environment agent state class This should be inherited and stored with additional state information relevant to the environment agent Should hold frequently passed data, such as synchronization information For infrequently passed data, please see SynAgentDescriptionMessage |
CSynFlatBuffersManager | Helper class that wraps the flatbuffers::FlatBufferBuilder |
CSynGPSTools | Holds a SynTerrain along with the GPS coordinate mapped to the origin of the vector space |
CSynMAPMessage | Store the Map information in the simulation |
CSynMessage | SynMessage is the base class for all messages Basically wraps the FlatBuffer methods to better handle the SynChrono message passing system Will be inherited from to create new message types |
CSynMessageFactory | Called by CommunicationManager to transform an incoming SynFlatBuffers::Message into a SynMessage |
CSynMPICommunicator | Derived communicator used to establish and facilitate communication between nodes |
CSynPose | Wrapper for several constructs that are common to many flatbuffer messages (Vectors, Quaternions, frames) |
CSynSCMMessage | SCM Message |
CSynSCMTerrainAgent | Class that wraps and synchronizes deformable terrain between Chrono Systems |
CSynSimulationMessage | This class contains diagnostic and simulation configuration based information that is typically passed between CommunicationManagers in the initialization phase |
CSynSPATMessage | SPAT Message |
CSynTrackedVehicleAgent | Agent wrapper of a tracked vehicle, in particular holds a pointer to a ChTrackedVehicle and sends out SynTrackedVehicleMessage-s to synchronize its state |
CSynTrackedVehicleDescriptionMessage | Description class that holds description information for a SynTrackedVehicle |
CSynTrackedVehicleStateMessage | State class that holds state information for a SynTrackedVehicleAgent |
CSynWheeledVehicleAgent | Agent wrapper of a wheeled vehicle, in particular holds a pointer to a ChWheeledVehicle and sends out SynWheeledVehicleMessage-s to synchronize its state |
CSynWheeledVehicleDescriptionMessage | Description class that holds description information for a SynWheeledVehicle |
CSynWheeledVehicleStateMessage | State class that holds state information for a SynWheeledVehicle |
►Nturtlebot | Namespace with classes for the Turtlebot model |
CTurtleBot | Turtlebot Robot class This class assemble and initialize a complete turtlebot robot This class also handles general control commands of the robot |
CTurtlebot_ActiveWheel | Turtlebot Active Drive Wheel class definition |
CTurtlebot_BottomPlate | Turtlebot Bottom Plate class definition |
CTurtlebot_Chassis | Turtlebot Chassis class definition |
CTurtlebot_MiddlePlate | Turtlebot Middle Plate class definition |
CTurtlebot_Part | Base class definition of the Turtlebot Robot Part |
CTurtlebot_PassiveWheel | Turtlebot Passive Driven Wheel class definition |
CTurtlebot_Rod_Long | Long Supporting Rod class definition |
CTurtlebot_Rod_Short | Short Supporting Rod class definition |
CTurtlebot_TopPlate | Turtlebot Top Plate class definition |
►Nutils | Chrono core utilities |
CChAbsorbedPowerVertical | Filter for vertical absorbed power |
CChAnalogueFilter | Base class for simulated analogue filters in the time domain |
CChBenchmarkFixture | Generic benchmark fixture for Chrono tests |
CChBenchmarkTest | Base class for a Chrono benchmark test |
►CChBodyGeometry | Utility class defining geometry (visualization and collision) and contact materials for a rigid body |
CBoxShape | Box shape for visualization and/or collision |
CConvexHullsShape | Convex hulls shape for collision |
CCylinderShape | Cylinder shape for visualization and/or collision |
CLineShape | Line shape for visualization |
CSphereShape | Sphere shape for visualization and/or collision |
CTrimeshShape | Tri-mesh shape for collision |
CChButterworthHighpass | Butterworth high-pass filter |
CChButterworthLowpass | Butterworth low-pass filter |
CChChaseCamera | Utility class for a generic chase camera which can be associated with any ChBody in a Chrono system |
CChControllerPID | Simple PID controller |
CChConvexHull2D | Simple 2D convex hull class |
CChFilterD | Caclulate the time derivation of an input signal: H(s) = Td * s |
CChFilterI | Calculate the integral of an input signal in the time domain: H(s) = 1 / ( Ti * s) |
CChFilterPD1 | PD1 controller: H(s) = Kdt1 * ( Td1 * s + 1 ) |
CChFilterPDT1 | PDT1 controller: H(s) = Kp * ( Td1 * s + 1 ) / ( T1 * s + 1) |
CChFilterPT1 | Delay an input signal: H(s) = Kpt1 / ( T1 * s + 1 ) |
►CChGenerator | Provides functionality for generating sets of bodies with positions drawn from a specified sampler and various mixture properties |
CCreateObjectsCallback | Class to be used as a callback interface for user-defined filtering of initial positions |
CChGridSampler | Sampler for 3D volumes using a regular (equidistant) grid |
CChHCPSampler | Sampler for 3D volumes using a Hexagonally Close Packed structure |
CChISO2631_1_Wd | Combined filter Wd |
CChISO2631_1_Wf | Combined filter Wf |
CChISO2631_1_Wk | Combined filter Wk |
CChISO2631_5_Wxy | ISO2631-5 weighting filter for shock like signal in horizontal direction |
CChISO2631_5_Wz | ISO2631-5 weighting filter for shock like signal in vertical direction |
CChISO2631_Shock_SeatCushionLogger | Easy to use class for evaluation of ISO 2361-5 shock load on sitting vehicle occupants |
CChISO2631_Vibration_SeatCushionLogger | Easy to use class for evaluation of ISO 2361-1 vibration load on sitting vehicle occupants Input: 3 seat accelerations x,y,z in [m/s^2] |
►CChMixtureIngredient | Encapsulation of an ingredient of one of the supported types in a mixture |
CAddBodyCallback | Class to be used as a callback interface for some user-defined action to be taken each time the generator creates and adds a body based on this mixture ingredient to the system |
CChMotionFilter | Base class for smoothing basic motion laws with discrete time-domain nonlinear filters |
CChMotionFilterSecondOrder | Second-order nonlinear filter for smoothing basic motion laws (e.g |
CChMotionFilterThirdOrder | Third-order nonlinear filter for smoothing basic motion laws (e.g |
CChMovingAverage | Moving average filter for smoothing a data array |
CChPDGrid | Simple 3D grid utility class for use by the Poisson Disk sampler |
CChPDSampler | Sampler for 3D domains (box, sphere, or cylinder) using Poisson Disk Sampling |
CChProfileIterator | An iterator to navigate through the tree |
CChProfileManager | The Manager for the Profile system |
CChProfileNode | A node in the Profile Hierarchy Tree |
CChProfileSample | Simple way to profile a function's scope |
CChRunningAverage | Moving average filter for smoothing running data |
CChSampler | Base class for different types of point samplers |
CChSocket | Base class for sockets. Sockets have at least an ID and a port |
CChSocketCommunication | Class for socket communication interface |
CChSocketFramework | A single object of this class must be instantiated before using all classes related to sockets, because it initializes some platform-specific settings |
CChSocketHostInfo | Class for storing information about a TCP host in socket communication, e.g. with an IP address |
CChSocketTCP | ChSocket for TCP communications |
►CChTSDAGeometry | Utility class defining visualization geometry for a TSDA |
CSegmentShape | Segment shape for TSDA visualization |
CSpringShape | Spring shape for TSDA visualization |
CChValidation | This class provides functionality for validation of simulation results |
CChWriterCSV | ChWriterCSV Simple class to output to a Comma-Separated Values ASCII file |
CCompositeInertia | Utility class for calculating inertia properties of a composite body |
►Nvehicle | Namespace with classes for the VEHICLE module |
►Nartcar | Namespace for the artcar vehicle model |
CARTcar | Definition of the ARTcar assembly |
CARTcar_AutomaticTransmissionSimpleMap | Simple ARTcar transmission subsystem |
CARTcar_BrakeShafts | Shafts-based Gator brake subsystem (uses a clutch between two shafts) |
CARTcar_BrakeSimple | Simple ARTcar brake subsystem (torque applied directly to the spindle joint) |
CARTcar_Chassis | ARTcar chassis subsystem |
CARTcar_DoubleWishboneFront | Full double wishbone front suspension for the ARTcar vehicle |
CARTcar_DoubleWishboneRear | Full double wishbone rear suspension for the ARTcar vehicle |
CARTcar_Driveline4WD | Shafts-based 4-WD driveline for the ARTcar vehicle |
CARTcar_EngineSimpleMap | Simple ARTcar powertrain subsystem (based on engine speed-torque maps) |
CARTcar_PitmanArm | Pitman-arm steering subsystem for the ARTcar vehicle |
CARTcar_RigidTire | Rigid tire model for the ARTcar vehicle |
CARTcar_TMeasyTire | TMeasy tire model for the ARTcar |
CARTcar_Vehicle | ARTcar vehicle system |
CARTcar_Wheel | ARTcar wheel base class |
CARTcar_WheelLeft | ARTcar left wheel (front or rear) |
CARTcar_WheelRight | ARTcar right wheel (front or rear) |
►Nbmw | Namespace for the BMW 330i vehicle model |
CBMW_E90 | Definition of the BMW_E90 assembly |
CBMW_E90_AntiRollBarFront | Anti-roll bar subsystem for a FEDA vehicle |
CBMW_E90_AntiRollBarRear | Anti-roll bar subsystem for a FEDA vehicle |
CBMW_E90_AutomaticTransmissionSimpleMap | Simple Sedan automatic transmission subsystem |
CBMW_E90_BrakeShafts | Shafts-based Sedan brake subsystem (uses a clutch between two shafts) |
CBMW_E90_Chassis | UAZBUS chassis subsystem |
CBMW_E90_DoubleWishbone | Full double wishbone rear suspension for the BMW E90 vehicle |
CBMW_E90_Driveline | Shafts-based 2-WD driveline for the Sedan vehicle |
CBMW_E90_EngineSimpleMap | Simple Sedan powertrain subsystem (based on engine speed-torque maps) |
CBMW_E90_FrontWheel | Sedan wheel (can be used on any axle, left or right) |
CBMW_E90_MacPhersonStrut | MacPherson Strut suspension model for a bmw e90 vehicle (can be used in front or rear) |
CBMW_E90_RearWheel | Sedan wheel (can be used on any axle, left or right) |
CBMW_E90_Steering | Rack-pinion steering subsystem for the BMW E90 vehicle |
CBMW_E90_TMeasyTireFront | TMeasy tire model for the BMW_E90 |
CBMW_E90_TMeasyTireRear | TMeasy tire model for the BMW_E90 |
CBMW_E90_TMsimpleTireFront | TMeasy tire model for the BMW 330i |
CBMW_E90_TMsimpleTireRear | TMsimple tire model for the BMW 330i |
CBMW_E90_Vehicle | Sedan vehicle system |
►Ncitybus | Namespace for the bus vehicle model |
CCityBus | Definition of the city bus assembly |
CCityBus_AutomaticTransmissionSimpleMap | Simple CityBus engine subsystem (based on engine speed-torque maps) |
CCityBus_BrakeShafts | Shafts-based CityBus brake subsystem (uses a clutch between two shafts) |
CCityBus_BrakeSimple | Simple CityBus brake subsystem (torque applied directly to the spindle joint) |
CCityBus_Chassis | CityBus chassis subsystem |
CCityBus_Driveline2WD | Shafts-based 2-WD driveline for the CityBus vehicle |
CCityBus_EngineSimpleMap | Simple CityBus engine subsystem (based on engine speed-torque maps) |
CCityBus_Pac02Tire | MF tire model for the FEDA vehicle |
CCityBus_RackPinion | Rack-pinion steering subsystem for the CityBus vehicle |
CCityBus_RigidTire | Rigid tire model for the CityBus vehicle |
CCityBus_SolidAxleFront | Solid-axle suspension subsystem for the city bus vehicle |
CCityBus_SolidAxleRear | Solid-axle rear suspension subsystem for the city bus vehicle |
CCityBus_TMeasyTire | TMeasy tire model for the Citybus vehicle |
CCityBus_Vehicle | Bus model with two axles and double tires on rear axle |
CCityBus_Wheel | CityBus wheel (can be used on any axle, left or right) |
►Nduro | Namespace for the Duro vehicle model |
CDuro | Definition of the Duro vehicle assembly |
CDuro_AutomaticTransmissionShafts | Shafts-based powertrain model for the Duro vehicle |
CDuro_BrakeShafts | Shafts-based HMMWV brake subsystem (uses a clutch between two shafts) |
CDuro_Chassis | Duro chassis subsystem |
CDuro_Driveline4WD | Shafts-based 4-WD driveline for the Duro vehicle |
CDuro_EngineShafts | Shafts-based engine model for the Duro vehicle |
CDuro_RigidTire | Rigid tire model for the Duro vehicle |
CDuro_RotaryArm | RotaryArm steering subsystem for the uaz vehicle |
CDuro_TMeasyTire | TMeasy tire model for the HMMWV |
CDuro_TMsimpleTire | TMeasy tire model for the Duro |
CDuro_ToeBarDeDionAxle | Leafspring axle subsystem for the duro vehicle |
CDuro_Vehicle | UAZ vehicle system |
CDuro_Wheel | Duro wheel (can be used on any axle, left or right) |
►Nfeda | Namespace for the FED-alpha vehicle model |
CFEDA | Definition of the FED-alpha assembly |
CFEDA_AntirollBarRSD | Anti-roll bar subsystem for a FEDA vehicle |
CFEDA_AutomaticTransmissionSimpleMap | Simple FEDA powertrain subsystem (based on engine speed-torque maps) |
CFEDA_BrakeShafts | Shafts-based FED-alpha brake subsystem (uses a clutch between two shafts) |
CFEDA_BrakeSimple | Simple FEDA brake subsystem (torque applied directly to the spindle joint) |
CFEDA_Chassis | FEDA chassis subsystem |
CFEDA_DoubleWishboneFront | Full double wishbone front suspension for the FEDA vehicle |
CFEDA_DoubleWishboneRear | Full double wishbone rear suspension for the FEDA vehicle |
CFEDA_Driveline4WD | Shafts-based 4-WD driveline for the FEDA vehicle |
CFEDA_EngineSimpleMap | Simple FEDA powertrain subsystem (based on engine speed-torque maps) |
CFEDA_Pac02Tire | MF tire model for the FEDA vehicle |
CFEDA_PitmanArm | Pitman-arm steering subsystem for the FEDA vehicle |
CFEDA_RigidTire | Rigid tire model for the FEDA vehicle |
CFEDA_TMeasyTire | TMeasy tire model for the FED Alpha |
CFEDA_TMsimpleTire | TMeasy tire model for the Fed Alpha |
CFEDA_Vehicle | FEDA vehicle system |
CFEDA_Wheel | FEDA wheel (can be used on any axle, left or right) |
►Nfmtv | Namespace for the FMTV vehicle models |
CFMTV_AntirollBarRSD | Anti-roll bar subsystem for an FMTV vehicle |
CFMTV_AutomaticTransmissionShafts | Shafts-based powertrain model for the FMTV vehicle |
CFMTV_AutomaticTransmissionSimple | FMTV automatic transmission model template based on a simple gear-shifting model |
CFMTV_AutomaticTransmissionSimpleMap | FMTV automatic transmission model template based on a simple gear-shifting model |
CFMTV_BrakeShafts | Shafts-based FMTV brake subsystem (uses a clutch between two shafts) |
CFMTV_BrakeSimple | FMTV simple brake subsystem (torque applied directly to the spindle joint) |
CFMTV_ChassisFront | FMTV front chassis subsystem (common for MTV and LMTV trucks) |
CFMTV_Driveline4WD | Shafts-based 4-WD driveline for the FMTV vehicles |
CFMTV_EngineShafts | Shafts-based engine model for the FMTV vehicle |
CFMTV_EngineSimple | FMTV simple engine model based on hyperbolical speed-torque curve (CVT) |
CFMTV_EngineSimpleMap | FMTV simple speed-torque engine map subsystem |
CFMTV_RigidTire | Rigid tire model for the FMTV vehicles |
CFMTV_RotaryArm | RotaryArm steering subsystem for the FMTV vehicles |
CFMTV_SimpleDriveline | Simple FMTV driveline subsystem (purely kinematic) |
CFMTV_TMeasyTire | TMeasy tire model for the FMTV vehicles |
CFMTV_ToebarLeafspringAxle | Toebar leafspring front axle subsystem for the FMTV vehicles |
CFMTV_Wheel | FMTV wheel (can be used on any axle, left or right) |
CLMTV | Definition of the LMTV assembly |
CLMTV_ChassisConnector | LMTV torsion chassis connector |
CLMTV_ChassisRear | LMTV rear chassis subsystem |
CLMTV_LeafspringAxle | Leafspring axle subsystem for the LMTV vehicle |
CLMTV_Vehicle | LMTV vehicle system |
CMTV | Definition of the MTV assembly |
CMTV_Balancer | MTV balancer subsystem (installed on rear chassis) |
CMTV_ChassisConnector | MTV torsion chassis connector |
CMTV_ChassisRear | MTV cargo truck (5 tons) rear chassis subsystems |
CMTV_LeafspringAxle1 | 1st rear Leafspring axle subsystem for the MTV vehicle |
CMTV_LeafspringAxle2 | 2nd rear Leafspring axle subsystem for the MTV vehicle |
CMTV_ShockForceRear | MTV rear shock functor class - implements a nonlinear damper |
CMTV_SpringForceRear | MTV rear spring functor class - implements a nonlinear spring |
CMTV_Vehicle | MTV vehicle system (5t truck) |
►Ngator | Namespace for the Gator vehicle model |
CGator | Definition of the Gator assembly |
CGator_AutomaticTransmissionSimple | Simple Gator powertrain subsystem (based on engine speed-torque maps) |
CGator_AutomaticTransmissionSimpleMap | Simple Gator powertrain subsystem (based on engine speed-torque maps) |
CGator_BrakeShafts | Shafts-based Gator brake subsystem (uses a clutch between two shafts) |
CGator_BrakeSimple | Simple Gator brake subsystem (torque applied directly to the spindle joint) |
CGator_Chassis | Gator chassis subsystem |
CGator_Driveline2WD | Shafts-based 2-WD driveline for the Gator vehicle |
CGator_EngineSimple | Simple Gator powertrain subsystem (DC motor linear torque-speed characteristic) |
CGator_EngineSimpleMap | Simple Gator powertrain subsystem (based on engine speed-torque maps) |
CGator_RackPinion | Rack-pinion steering subsystem for the Gator vehicle |
CGator_RigidSuspension | Rigid suspension for the Gator vehicle (spindles directly attached to chassis) |
CGator_RigidTire_Front | Rigid tire model for the Gator vehicle (front) |
CGator_RigidTire_Rear | Rigid tire model for the Gator vehicle (rear) |
CGator_SimpleDriveline | Simple Gator driveline subsystem (purely kinematic) |
CGator_SingleWishbone | Single wishbone suspension model for the Gator vehicle (front) |
CGator_TMeasyTire_Front | TMeasy tire model for the Gator (front) |
CGator_TMeasyTire_Rear | TMeasy tire model for the Gator (rear) |
CGator_Vehicle | Gator vehicle system |
CGator_Wheel | Gator wheel (can be used on any axle, left or right) |
►Ngclass | Namespace for the Mercedes G500 vehicle model |
CG500 | Definition of the gclass assembly |
CG500_AutomaticTransmissionSimpleMap | Simple UAZBUS powertrain subsystem (based on engine speed-torque maps) |
CG500_BrakeShaftsFront | Shafts-based UAZ front brake subsystem (uses a clutch between two shafts) |
CG500_BrakeShaftsRear | Shafts-based UAZ rear brake subsystem (uses a clutch between two shafts) |
CG500_BrakeSimpleFront | Simple UAZBUS front brake subsystem (torque applied directly to the spindle joint) |
CG500_BrakeSimpleRear | Simple UAZBUS rear brake subsystem (torque applied directly to the spindle joint) |
CG500_Chassis | UAZBUS chassis subsystem |
CG500_Driveline4WD | Shafts-based 4-WD driveline for the UAZBUS vehicle |
CG500_EngineSimpleMap | Simple UAZBUS powertrain subsystem (based on engine speed-torque maps) |
CG500_FrontAxle | Leafspring axle subsystem for the uaz vehicle |
CG500_RearAxle | Leafspring axle subsystem for the uaz vehicle |
CG500_RigidTire | Rigid tire model for the UAZBUS vehicle |
CG500_RotaryArm | RotaryArm steering subsystem for the uaz vehicle |
CG500_TMeasyTireFront | TMeasy tire model for the UAZBUS (front) |
CG500_TMeasyTireRear | TMeasy tire model for the G500 (rear) |
CG500_Vehicle | UAZ vehicle system |
CG500_Wheel | UAZBUS wheel (can be used on any axle, left or right) |
►Ngeneric | Namespace for the generic wheeled vehicle model |
CGeneric_AntirollBarRSD | Anti-roll bar subsystem for a generic vehicle |
CGeneric_AutomaticTransmissionShafts | Shafts-based powertrain model for the generic vehicle |
CGeneric_AutomaticTransmissionSimpleMap | Custom automatic transmission model for a generic vehicle |
CGeneric_BrakeShafts | Shafts-based generic vehicle brake subsystem (uses a clutch between two shafts) |
CGeneric_BrakeSimple | Simple brake subsystem for the generic vehicle (torque applied directly to the spindle joint) |
CGeneric_Chassis | Chassis subsystem for a generic vehicle |
CGeneric_DoubleWishbone | Double wishbone suspension model for a generic vehicle (can be used in front or rear) |
CGeneric_DoubleWishboneFront | Full double wishbone front suspension for the generic vehicle vehicle |
CGeneric_DoubleWishboneRear | Full double wishbone rear suspension for the generic vehicle |
CGeneric_DoubleWishboneReducedFront | Reduced double wishbone front suspension for the generic vehicle |
CGeneric_DoubleWishboneReducedRear | Reduced double wishbone rear suspension for the generic vehicle |
CGeneric_Driveline2WD | Shafts-based 2-WD driveline model for a generic vehicle |
CGeneric_Driveline4WD | Shafts-based 4-WD driveline for the generic vehicle |
CGeneric_EngineShafts | Shafts-based engine model for the generic vehicle |
CGeneric_EngineSimple | Simple engine model for the generic vehicle (purely kinematic) |
CGeneric_EngineSimpleMap | Engine model for a generic vehicle |
CGeneric_FialaTire | Fiala tire model for the Generic vehicle vehicle |
CGeneric_HendricksonPRIMAXX | Hendrickson PRIMAXX suspension for a generic vehicle |
CGeneric_MacPhersonStrut | MacPherson strut suspension for a generic vehicle |
CGeneric_MultiLink | Multi-link suspension for a generic vehicle |
CGeneric_Pac02Tire | MF tire model for the FEDA vehicle |
CGeneric_Pac89Tire | PAC89 tire model for the Generic vehicle vehicle |
CGeneric_PitmanArm | Pitman-arm steering subsystem for the genmeric vehicle |
CGeneric_RackPinion | Rack-pinion steering model for a generic vehicle |
CGeneric_RigidMeshTire | Rigid tire model (mesh contact) for the generic vehicle |
CGeneric_RigidPinnedAxle | Rigid pinned axle suspension for a generic vehicle (spindles attached to a rigid axle) |
CGeneric_RigidSuspension | Rigid suspension for a generic vehicle (spindles directly attached to chassis) |
CGeneric_RigidTire | Rigid tire model for the Generic vehicle vehicle |
CGeneric_SimpleDriveline | Simple driveline model for the generic vehicle (purely kinematic) |
CGeneric_SolidAxle | Solid-axle suspension subsystem for the generic vehicle |
CGeneric_TMeasyTire | TMeasy tire model for the Generic vehicle |
CGeneric_TMsimpleTire | TMeasy tire model for the Generic vehicle |
CGeneric_Vehicle | Definition of a Generic wheeled vehicle |
CGeneric_Wheel | Wheel subsystem for the generic vehicle |
►Nhmmwv | Namespace for the HMMWV vehicle model |
CHMMWV | Definition of the HMMWV assembly |
CHMMWV_ANCFTire | Deformable tire model for the HMMWV vehicle (using ANCF shell FEA elements) |
CHMMWV_AutomaticTransmissionShafts | Shafts-based powertrain model for the HMMWV vehicle |
CHMMWV_AutomaticTransmissionSimpleMap | HMMWV automatic transmission model template based on a simple gear-shifting model |
CHMMWV_BrakeShafts | Shafts-based HMMWV brake subsystem (uses a clutch between two shafts) |
CHMMWV_BrakeSimple | Simple HMMWV brake subsystem (torque applied directly to the spindle joint) |
CHMMWV_Chassis | HMMWV chassis subsystem |
CHMMWV_DoubleWishboneFront | Full double wishbone front suspension for the HMMWV vehicle |
CHMMWV_DoubleWishboneRear | Full double wishbone rear suspension for the HMMWV vehicle |
CHMMWV_DoubleWishboneReducedFront | Reduced double wishbone front suspension for the HMMWV vehicle |
CHMMWV_DoubleWishboneReducedRear | Reduced double wishbone rear suspension for the HMMWV vehicle |
CHMMWV_Driveline2WD | Shafts-based 2-WD driveline for the HMMWV vehicle |
CHMMWV_Driveline4WD | Shafts-based 4-WD driveline for the HMMWV vehicle |
CHMMWV_EngineShafts | Shafts-based engine model for the HMMWV vehicle |
CHMMWV_EngineSimple | HMMWV simple engine model based on hyperbolical speed-torque curve (CVT) |
CHMMWV_EngineSimpleMap | HMMWV simple speed-torque engine map subsystem |
CHMMWV_FialaTire | Fiala tire model for the HMMWV vehicle |
CHMMWV_Full | Definition of a HMMWV vehicle assembly (vehicle, powertrain, and tires), using full double wishbone suspensions (i.e., suspensions that include rigid bodies for the upper and lower control arms) and a Pitman arm steering mechanism |
CHMMWV_Pac02Tire | MF tire model for the FEDA vehicle |
CHMMWV_Pac89Tire | PAC89 tire model for the HMMWV vehicle |
CHMMWV_PitmanArm | Pitman-arm steering subsystem for the HMMWV vehicle |
CHMMWV_PitmanArmShafts | Pitman-arm with compliant column steering subsystem for the HMMWV vehicle |
CHMMWV_RackPinion | Rack-pinion steering subsystem for the HMMWV vehicle |
CHMMWV_Reduced | Definition of a HMMWV vehicle assembly (vehicle, powertrain, and tires), using reduced double wishbone suspensions (i.e., suspensions that replace the upper and lower control arms with distance constraints) and a rack-pinion steering mechanism |
CHMMWV_ReissnerTire | Deformable tire model for the HMMWV vehicle (using Reissner shell FEA elements) |
CHMMWV_RigidTire | Rigid tire model for the HMMWV vehicle |
CHMMWV_SimpleDriveline | Simple HMMWV driveline subsystem (purely kinematic) |
CHMMWV_TMeasyTire | TMeasy tire model for the HMMWV |
CHMMWV_TMsimpleTire | TMeasy tire model for the HMMWV |
CHMMWV_Vehicle | Base class for a HMMWV vehicle |
CHMMWV_VehicleFull | HMMWV vehicle system using full double wishbone suspension (control arms modeled using rigid bodies) and Pitman arm steering mechanism |
CHMMWV_VehicleReduced | HMMWV vehicle system using reduced double wishbone suspension (control arms modeled using distance constraints) and rack-pinion steering mechanism |
CHMMWV_Wheel | HMMWV wheel (can be used on any axle, left or right) |
►Njeep | Namespace for the Jeep Cherokee vehicle model |
CCherokee | Definition of the Jeep Cherokee assembly |
CCherokee_AutomaticTransmissionShafts | Shafts-based powertrain model for the Cherokee vehicle |
CCherokee_AutomaticTransmissionSimpleMap | HMMWV automatic transmission model template based on a simple gear-shifting model |
CCherokee_BrakeShafts | Shafts-based Cherokee brake subsystem (uses a clutch between two shafts) |
CCherokee_Chassis | Jeep Cherokee chassis subsystem |
CCherokee_Driveline4WD | Shafts-based 4-WD driveline for the Jeep Cherokee vehicle |
CCherokee_EngineShafts | Shafts-based engine model for the Jeep Cherokee vehicle |
CCherokee_EngineSimpleMap | Jeep simple speed-torque engine map subsystem |
CCherokee_RigidTire | Rigid tire model for the Jeep Cherokee vehicle |
CCherokee_Steering | RotaryArm steering subsystem for the FMTV vehicles |
CCherokee_TMeasyTire | TMeasy tire model for the Jeep Cherokee |
CCherokee_Vehicle | Sedan vehicle system |
CCherokee_Wheel | Jeep Cherokee wheel (can be used on any axle, left or right) |
►Nkraz | Namespace for the Kraz truck vehicle model |
CKraz | Definition of the Kraz 64431 semi-trailer truck assembly |
CKraz_tractor | Kraz tractor system |
CKraz_tractor_AutomaticTransmissionSimpleMap | Simple Kraz tractor powertrain subsystem (based on engine speed-torque maps) |
CKraz_tractor_Brake | Simple Kraz tractor brake subsystem (torque applied directly to the spindle joint) |
CKraz_tractor_Chassis | Kraz tractor chassis subsystem |
CKraz_tractor_Driveline | Shafts-based 4-WD driveline for the Kraz tractor |
CKraz_tractor_EngineSimpleMap | Simple Kraz tractor EngineSimpleMap subsystem (based on engine speed-torque maps) |
CKraz_tractor_FrontSuspension | Leafspring front axle subsystem for the Kraz tractor |
CKraz_tractor_RearSuspension | Leafspring rear axle subsystem for the Kraz tractor |
CKraz_tractor_Steering | RotaryArm steering subsystem for the Kraz tractor |
CKraz_tractor_Tire | TMeasy tire model for the Kraz tractor |
CKraz_tractor_Wheel | Kraz tractor wheel (can be used on any axle, left or right) |
CKraz_trailer | Kraz trailer system |
CKraz_trailer_Brake | Simple Kraz trailer brake subsystem (torque applied directly to the spindle joint) |
CKraz_trailer_Chassis | Kraz trailer chassis subsystem |
CKraz_trailer_Connector | Kraz tractor-trailer fifth wheel connector subsystem |
CKraz_trailer_Suspension | Leafspring axle subsystem for the Kraz trailer |
CKraz_trailer_Tire | TMeasy tire model for the Kraz trailer |
CKraz_trailer_Wheel | Kraz trailer wheel (can be used on any axle, left or right) |
►Nm113 | Namespace for the M113 track vehicle model |
CM113 | Definition of the m113 assembly |
CM113_AutomaticTransmissionShafts | Shafts-based powertrain model for the M113 vehicle |
CM113_AutomaticTransmissionSimple | M113 automatic transmission model template based on a simple gear-shifting model |
CM113_AutomaticTransmissionSimpleMap | M113 automatic transmission model template based on a simple gear-shifting model |
CM113_BrakeShafts | Shafts-based M113 brake subsystem (uses a clutch between two shafts) |
CM113_BrakeSimple | Simple M113 brake subsystem (torque applied directly to the spindle joint) |
CM113_Chassis | M113 chassis subsystem |
CM113_DrivelineBDS | Shafts-based driveline model for the M113 vehicle |
CM113_EngineShafts | Shafts-based engine model for the M113 vehicle |
CM113_EngineSimple | M113 simple engine model based on hyperbolical speed-torque curve (CVT) |
CM113_EngineSimpleMap | M113 simple speed-torque engine map subsystem |
CM113_Idler | Idler and tensioner model for the M113 vehicle |
CM113_IdlerWheel | Idler-wheel model for the M113 vehicle (base class) |
CM113_IdlerWheelLeft | Idler-wheel model for the M113 vehicle (left side) |
CM113_IdlerWheelRight | Idler-wheel model for the M113 vehicle (right side) |
CM113_RoadWheel | Road-wheel model for the M113 vehicle (base class) |
CM113_RoadWheelLeft | Road-wheel model for the M113 vehicle (left side) |
CM113_RoadWheelRight | Road-wheel model for the M113 vehicle (right side) |
CM113_SimpleDriveline | Simple driveline model for the M113 vehicle (purely kinematic) |
CM113_SprocketBand | M113 sprocket subsystem for continuous band track (base class) |
CM113_SprocketBandLeft | M113 sprocket subsystem for continuous band track (left side) |
CM113_SprocketBandRight | M113 sprocket subsystem for continuous band track (right side) |
CM113_SprocketDoublePin | M113 sprocket subsystem, suitable for interaction with double-pin track shoes (base class) |
CM113_SprocketDoublePinLeft | M113 sprocket subsystem, suitable for interaction with double-pin track shoes (left side) |
CM113_SprocketDoublePinRight | M113 sprocket subsystem, suitable for interaction with double-pin track shoes (right side) |
CM113_SprocketSinglePin | M113 sprocket subsystem, suitable for interaction with single-pin track shoes (base class) |
CM113_SprocketSinglePinLeft | M113 sprocket subsystem, suitable for interaction with single-pin track shoes (left side) |
CM113_SprocketSinglePinRight | M113 sprocket subsystem, suitable for interaction with single-pin track shoes (right side) |
CM113_Suspension | Linear-damper M113 track suspension |
CM113_TrackAssemblyBandANCF | M113 continuous band track assembly subsystem using rigid-link track shoes |
CM113_TrackAssemblyBandBushing | M113 continuous band track assembly subsystem using rigid-link track shoes |
CM113_TrackAssemblyDoublePin | M113 track assembly using double-pin track shoes |
CM113_TrackAssemblySinglePin | M113 track assembly using single-pin track shoes |
CM113_TrackShoeBandANCF | Continuous band rigid-link track shoe subsystem for the M113 vehicle |
CM113_TrackShoeBandBushing | Continuous band rigid-link track shoe subsystem for the M113 vehicle |
CM113_TrackShoeDoublePin | Double-pin track shoe subsystem for the M113 vehicle |
CM113_TrackShoeSinglePin | Single-pin track shoe subsystem for the M113 vehicle |
CM113_Vehicle | Base class for an M113 tracked vehicle with segmented or band tracks |
CM113_Vehicle_BandANCF | M113 vehicle with ANCF-based continuous tracks |
CM113_Vehicle_BandBushing | M113 vehicle with bushings-based continuous tracks |
CM113_Vehicle_DoublePin | M113 vehicle with segmented double-pin track shoes |
CM113_Vehicle_SinglePin | M113 vehicle with segmented single-pin track shoes |
►Nman | Namespace for the MAN truck vehicle models |
CMAN_10t | Wrapper class for modeling an entire MAN 10t vehicle assembly (including the vehicle itself, the powertrain, and the tires) |
CMAN_10t_Chassis | MAN 10t chassis subsystem |
CMAN_10t_RotaryArm2 | RotaryArm steering subsystem for the uaz vehicle |
CMAN_5t | Wrapper class for modeling an entire MAN 5t vehicle assembly (including the vehicle itself, the powertrain, and the tires) |
CMAN_5t_AutomaticTransmissionSimple | Simple MAN_5t powertrain subsystem (based on engine speed-torque maps) |
CMAN_5t_AutomaticTransmissionSimpleMap | Simple MAN_5t powertrain subsystem (based on engine speed-torque maps) |
CMAN_5t_BrakeShafts | Shafts-based MAN brake subsystem (uses a clutch between two shafts) |
CMAN_5t_BrakeSimple | Simple MAN brake subsystem (torque applied directly to the spindle joint) |
CMAN_5t_Chassis | MAN 5t chassis subsystem |
CMAN_5t_Driveline4WD | Shafts-based 4-WD driveline for the MAN 5t vehicle |
CMAN_5t_EngineSimple | MAN_5t simple engine model based on hyperbolical speed-torque curve (CVT) |
CMAN_5t_EngineSimpleMap | Simple MAN_5t powertrain subsystem (based on engine speed-torque maps) |
CMAN_5t_RotaryArm | RotaryArm steering subsystem for the uaz vehicle |
CMAN_5t_SimpleDriveline | Simple MAN 5t driveline subsystem (purely kinematic) |
CMAN_5t_SimpleDrivelineXWD | Simple MAN 5t driveline subsystem (purely kinematic) |
CMAN_5t_TMeasyTire | TMeasy tire model for the MAN 5t truck vehicle |
CMAN_5t_TMsimpleTire | TMeasy tire model for the U401 |
CMAN_5t_Wheel | MAN wheel (can be used on any axle, left or right) |
CMAN_7t | Wrapper class for modeling an entire MAN 7t vehicle assembly (including the vehicle itself, the powertrain, and the tires) |
CMAN_7t_AutomaticTransmissionSimple | Simple MAN_7t powertrain subsystem (based on engine speed-torque maps) |
CMAN_7t_AutomaticTransmissionSimpleMap | Simple MAN_7t powertrain subsystem (based on engine speed-torque maps) |
CMAN_7t_Chassis | MAN 7t chassis subsystem |
CMAN_7t_EngineSimple | MAN_5t simple engine model based on hyperbolical speed-torque curve (CVT) |
CMAN_7t_EngineSimpleMap | Simple MAN_7t powertrain subsystem (based on engine speed-torque maps) |
►Nmarder | Namespace for the Marder track vehicle model |
CMarder | Definition of the marder assembly |
CMarder_AutomaticTransmissionShafts | Shafts-based powertrain model for the Marder vehicle |
CMarder_AutomaticTransmissionSimple | Marder automatic transmission model template based on a simple gear-shifting model |
CMarder_AutomaticTransmissionSimpleMap | Marder automatic transmission model template based on a simple gear-shifting model |
CMarder_BrakeShafts | Shafts-based Marder brake subsystem (uses a clutch between two shafts) |
CMarder_BrakeSimple | Simple M113 brake subsystem (torque applied directly to the spindle joint) |
CMarder_Chassis | Marder chassis subsystem |
CMarder_EngineShafts | Shafts-based engine model for the Marder vehicle |
CMarder_EngineSimple | Marder simple engine model based on hyperbolical speed-torque curve (CVT) |
CMarder_EngineSimpleMap | Marder simple speed-torque engine map subsystem |
CMarder_Idler | Idler and tensioner model for the Marder vehicle |
CMarder_IdlerWheel | Idler-wheel model for the Marder vehicle (base class) |
CMarder_IdlerWheelLeft | Idler-wheel model for the M113 vehicle (left side) |
CMarder_IdlerWheelRight | Idler-wheel model for the M113 vehicle (right side) |
CMarder_RoadWheel | Road-wheel model for the Marder vehicle (base class) |
CMarder_RoadWheelLeft | Road-wheel model for the M113 vehicle (left side) |
CMarder_RoadWheelRight | Road-wheel model for the M113 vehicle (right side) |
CMarder_SimpleDriveline | Simple driveline model for the Marder vehicle (purely kinematic) |
CMarder_SprocketSinglePin | Marder sprocket subsystem, suitable for interaction with single-pin track shoes (base class) |
CMarder_SprocketSinglePinLeft | M113 sprocket subsystem, suitable for interaction with single-pin track shoes (left side) |
CMarder_SprocketSinglePinRight | M113 sprocket subsystem, suitable for interaction with single-pin track shoes (right side) |
CMarder_SupportRoller | Support roller model for the Marder vehicle (base class) |
CMarder_SupportRollerLeft | Road-wheel model for the M113 vehicle (left side) |
CMarder_SupportRollerRight | Road-wheel model for the M113 vehicle (right side) |
CMarder_Suspension | Linear-damper Marder track suspension |
CMarder_TrackAssemblySinglePin | Marder track assembly using single-pin track shoes |
CMarder_TrackShoeSinglePin | Single-pin track shoe subsystem for the Marder vehicle |
CMarder_Vehicle | Definition of an Marder tracked vehicle with segmented tracks |
►Nmrole | Namespace for the MROLE multi-purpose wheeled vehicle model |
Cmrole | Definition of the mrole assembly |
Cmrole_AutomaticTransmissionShafts | Shafts-based powertrain model for the mrole vehicle |
Cmrole_AutomaticTransmissionSimpleMap | Mrole automatic transmission model template based on a simple gear-shifting model |
Cmrole_BrakeShafts | Shafts-based mrole brake subsystem (uses a clutch between two shafts) |
Cmrole_BrakeSimple | Simple mrole brake subsystem (torque applied directly to the spindle joint) |
Cmrole_Chassis | Mrole chassis subsystem |
Cmrole_DoubleWishboneFront | Full double wishbone front suspension for the mrole vehicle |
Cmrole_DoubleWishboneRear | Full double wishbone rear suspension for the mrole vehicle |
Cmrole_DoubleWishboneReducedFront | Reduced double wishbone front suspension for the mrole vehicle |
Cmrole_DoubleWishboneReducedRear | Reduced double wishbone rear suspension for the mrole vehicle |
Cmrole_Driveline2WD | Shafts-based 2-WD driveline for the mrole vehicle |
Cmrole_Driveline4WD | Shafts-based 4-WD driveline for the mrole vehicle |
Cmrole_Driveline6WD | Shafts-based 6-WD driveline for the mrole vehicle |
Cmrole_Driveline8WD | Shafts-based 8-WD driveline for the mrole vehicle |
Cmrole_EngineShafts | Shafts-based engine model for the mrole vehicle |
Cmrole_EngineSimple | Mrole simple engine model based on hyperbolical speed-torque curve (CVT) |
Cmrole_EngineSimpleMap | Mrole simple speed-torque engine map subsystem |
Cmrole_Full | Definition of a mrole vehicle assembly (vehicle, powertrain, and tires), using full double wishbone suspensions (i.e., suspensions that include rigid bodies for the upper and lower control arms) and a Pitman arm steering mechanism |
Cmrole_PitmanArm | Pitman-arm steering subsystem for the mrole vehicle |
Cmrole_PitmanArmShafts | Pitman-arm with compliant column steering subsystem for the mrole vehicle |
Cmrole_RackPinion1 | Rack-pinion steering subsystem for the mrole vehicle, first axle |
Cmrole_RackPinion2 | Rack-pinion steering subsystem for the mrole vehicle, second axle |
Cmrole_Reduced | Definition of a mrole vehicle assembly (vehicle, powertrain, and tires), using reduced double wishbone suspensions (i.e., suspensions that replace the upper and lower control arms with distance constraints) and a rack-pinion steering mechanism |
Cmrole_RigidTire | Rigid tire model for the mrole vehicle |
Cmrole_SimpleDriveline | Simple mrole driveline subsystem (purely kinematic) |
Cmrole_SimpleDrivelineXWD | Simple MAN 5t driveline subsystem (purely kinematic) |
Cmrole_TMeasyTire | TMeasy tire model for the mrole, for ON ROAD operation |
Cmrole_TMeasyTireSand | TMeasy tire model for the mrole, for OFFROAD operation on deformable sand |
Cmrole_TMeasyTireSoil | TMeasy tire model for the mrole, for OFFROAD operation on deformable soils |
Cmrole_Vehicle | Base class for a mrole vehicle |
Cmrole_VehicleFull | Mrole vehicle system using full double wishbone suspension (control arms modeled using rigid bodies) and Pitman arm steering mechanism |
Cmrole_VehicleReduced | Mrole vehicle system using reduced double wishbone suspension (control arms modeled using distance constraints) and rack-pinion steering mechanism |
Cmrole_Wheel | Mrole wheel (can be used on any axle, left or right) |
►Nsedan | Namespace for the passenger vehicle model |
CSedan | Definition of the sedan assembly |
CSedan_AutomaticTransmissionSimpleMap | Simple Sedan automatic transmission subsystem |
CSedan_BrakeShafts | Shafts-based Sedan brake subsystem (uses a clutch between two shafts) |
CSedan_BrakeSimple | Simple Sedan brake subsystem (torque applied directly to the spindle joint) |
CSedan_Chassis | Sedan chassis subsystem |
CSedan_DoubleWishbone | Double wishbone suspension model for a sedan vehicle (can be used in front or rear) |
CSedan_Driveline2WD | Shafts-based 2-WD driveline for the Sedan vehicle |
CSedan_EngineSimpleMap | Simple Sedan powertrain subsystem (based on engine speed-torque maps) |
CSedan_MultiLink | Multi-link suspension for a sedan vehicle |
CSedan_Pac02Tire | MF tire model for the FEDA vehicle |
CSedan_RackPinion | Rack-pinion steering subsystem for the Sedan vehicle |
CSedan_RigidTire | Rigid tire model for the Sedan vehicle |
CSedan_TMeasyTire | TMeasy tire model for the Sedan vehicle |
CSedan_TMsimpleTire | TMeasy tire model for the Sedan vehicle |
CSedan_Vehicle | Sedan vehicle system |
CSedan_Wheel | Sedan wheel (can be used on any axle, left or right) |
►Nuaz | Namespace for the UAZ vehicle model |
CUAZBUS | Definition of the UAZ assembly |
CUAZBUS_AutomaticTransmissionSimpleMap | Simple UAZBUS powertrain subsystem (based on engine speed-torque maps) |
CUAZBUS_BrakeShaftsFront | Shafts-based UAZ front brake subsystem (uses a clutch between two shafts) |
CUAZBUS_BrakeShaftsRear | Shafts-based UAZ rear brake subsystem (uses a clutch between two shafts) |
CUAZBUS_BrakeSimpleFront | Simple UAZBUS front brake subsystem (torque applied directly to the spindle joint) |
CUAZBUS_BrakeSimpleRear | Simple UAZBUS rear brake subsystem (torque applied directly to the spindle joint) |
CUAZBUS_Chassis | UAZBUS chassis subsystem |
CUAZBUS_Driveline2WD | Shafts-based 2-WD driveline for the UAZBUS vehicle |
CUAZBUS_Driveline4WD | Shafts-based 4-WD driveline for the UAZBUS vehicle |
CUAZBUS_EngineSimpleMap | Simple UAZBUS powertrain subsystem (based on engine speed-torque maps) |
CUAZBUS_LeafspringAxle | Leafspring axle subsystem for the uaz vehicle |
CUAZBUS_Pac02Tire | MF tire model for the UAZBUS vehicle |
CUAZBUS_RigidTire | Rigid tire model for the UAZBUS vehicle |
CUAZBUS_RotaryArm | RotaryArm steering subsystem for the uaz vehicle |
CUAZBUS_SAE | Definition of the UAZ assembly |
CUAZBUS_SAELeafspringAxle | Leafspring axle subsystem for the uaz vehicle |
CUAZBUS_SAEToeBarLeafspringAxle | Leafspring axle subsystem for the uaz vehicle |
CUAZBUS_SAEVehicle | UAZ vehicle system |
CUAZBUS_TMeasyTireFront | TMeasy tire model for the UAZBUS (front) |
CUAZBUS_TMeasyTireRear | TMeasy tire model for the UAZBUS (front) |
CUAZBUS_ToeBarLeafspringAxle | Leafspring axle subsystem for the uaz vehicle |
CUAZBUS_Vehicle | UAZ vehicle system |
CUAZBUS_Wheel | UAZBUS wheel (can be used on any axle, left or right) |
►Nunimog | Namespace for the Unimog 401 vehicle model |
CU401 | Definition of the UAZ assembly |
CU401_AutomaticTransmissionSimpleMap | Simple U401 powertrain subsystem (based on engine speed-torque maps) |
CU401_BrakeShafts | Shafts-based HMMWV brake subsystem (uses a clutch between two shafts) |
CU401_BrakeSimple | Simple HMMWV brake subsystem (torque applied directly to the spindle joint) |
CU401_Chassis | U401 chassis subsystem |
CU401_Driveline2WD | Shafts-based 2-WD driveline for the UAZBUS vehicle |
CU401_Driveline4WD | Shafts-based 4-WD driveline for the UAZBUS vehicle |
CU401_EngineSimpleMap | Simple U401 powertrain subsystem (based on engine speed-torque maps) |
CU401_FialaTire | Fiala tire model for the U401unimgo vehicle |
CU401_PushPipeAxle | Leafspring axle subsystem for the uaz vehicle |
CU401_RigidTire | Rigid tire model for the U401 vehicle |
CU401_RotaryArm | RotaryArm steering subsystem for the uaz vehicle |
CU401_TMeasyTire | TMeasy tire model for the HMMWV |
CU401_TMsimpleTire | TMeasy tire model for the U401 |
CU401_ToeBarPushPipeAxle | Leafspring axle subsystem for the uaz vehicle |
CU401_Vehicle | UAZ vehicle system |
CU401_Wheel | HMMWV wheel (can be used on any axle, left or right) |
CAIDriver | Driver |
CANCFTire | ANCF tire constructed with data from file (JSON format) |
CAntirollBarRSD | RSD antirollbar model constructed with data from file (JSON format) |
CAutomaticTransmissionShafts | Shafts-based automatic transmission subsystem (specified through JSON file) |
CAutomaticTransmissionSimpleCVT | Automatic transmission model template based on a simple gear-shifting model (specified through JSON file) |
CAutomaticTransmissionSimpleMap | Automatic transmission model template based on a simple gear-shifting model (specified through JSON file) |
CBalancer | Balancer subchassis system constructed with data from file |
CBodyState | Structure to communicate a full body state |
CBrakeShafts | Wheeled vehicle shafts-based brake model constructed with data from file (JSON format) |
CBrakeSimple | Vehicle simple brake model constructed with data from file (JSON format) |
CChAdaptiveSpeedController | Data collection from the speed controller can be started (restarted) and suspended (stopped) as many times as desired |
CChAIDriver | Driver |
►CChANCFTire | ANCF tire template |
CProfile | Tire profile |
CSection | Tire section |
CChAntirollBar | Base class for an anti-roll bar subsystem |
CChAntirollBarRSD | Template for an anti-roll subsystem using an RSD |
CChassisConnectorArticulated | Articulated chassis connector model constructed with data from file (JSON format) |
CChassisConnectorFifthWheel | Fifth wheel chassis connector model constructed with data from file (JSON format) |
CChassisConnectorHitch | Hitch chassis connector model constructed with data from file (JSON format) |
CChassisConnectorTorsion | Torsion chassis connector model constructed with data from file (JSON format) |
CChAutomaticTransmissionShafts | Template for an automatic transmission model using shaft elements |
CChAutomaticTransmissionSimpleMap | Template for an automatic transmission model based on a simple gear-shifting model |
CChAxle | Base class for a suspension subsystem |
CChBalancer | Template for a balancer subchassis system |
CChBrake | Base class for a brake subsystem |
CChBrakeShafts | Brake for wheeled vehicles modeled using a clutch between two shafts |
CChBrakeSimple | Template for a simple brake subsystem |
►CChChassis | Base class for the chassis vehicle subsystem |
CExternalForceTorque | Base class for a user-defined custom force/torque acting on the chassis body |
CChChassisConnector | Base class for a chassis connector subsystem |
CChChassisConnectorArticulated | Template for an articulation chassis connector |
CChChassisConnectorFifthWheel | Template for a fifth-wheel chassis connector |
CChChassisConnectorHitch | Template for a hitch chassis connector. This is a passive connector, modeled with a spherical joint |
CChChassisConnectorTorsion | Template for a torsion chassis connector |
CChChassisRear | Base class for a rear chassis vehicle subsystem |
CChClosedLoopDriver | Base class for closed-loop path-follower driver modesl |
►CChDataDriver | Driver inputs from data file |
CEntry | Definition of driver inputs at a given time |
CChDeDionAxle | Base class for a DeDion solid axle suspension |
►CChDeformableTire | Base class for a deformable tire model |
CProfile | Tire profile definition |
CChDistanceIdler | Base class for an idler subsystem with a fixed distance tensioner |
CChDoubleTrackWheel | Base class for a double track wheel (template definition) |
CChDoubleWishbone | Base class for a double-A arm suspension modeled with bodies and constraints |
CChDoubleWishboneReduced | Base class for a double-A arm suspension modeled with distance constraints |
CChDriveline | Base class for a vehicle driveline subsystem |
CChDrivelineTV | Base class for a tracked vehicle driveline |
CChDrivelineWV | Base class for a wheeled vehicle driveline subsystem |
CChDriver | Base class for a vehicle driver system |
CChEngine | Base class for an engine subsystem |
CChEngineShafts | Template for an engine model using shaft elements |
CChEngineSimple | Template for simplified engine model |
CChEngineSimpleMap | Template for simple engine model based on speed-torque engine maps |
CChFEATire | Co-rotational FEA tire template |
CChFialaTire | Fiala based tire model |
►CChForceElementTire | Base class for a force element (handling) tire model |
CContactData | Tire contact information |
►CChGenericWheeledSuspension | Base class for a generic wheeled vehicle suspension |
CBodyIdentifier | Identification of a body in the suspension subsystem |
CChassisIdentifier | Identification of the vehicle chassis body |
CSteeringIdentifier | Identification of a vehicle steering link body |
CSubchassisIdentifier | Identification of a vehicle subchassis body |
CChHendricksonPRIMAXX | Base class for a Hendrickson PRIMAXX EX suspension |
CChHumanDriver | Closed-loop path-follower and speed maintaining driver model |
CChIdler | Base class for an idler subsystem |
CChInteractiveDriver | Interactive driver for the a vehicle |
CChInteractiveDriverIRR | Irrlicht-based interactive driver for the a vehicle |
CChInteractiveDriverVSG | VSG-based interactive driver for the a vehicle |
CChJoystickAxisIRR | Irrlicht interface to a specific joystick axis and its calibration data |
CChJoystickButtonIRR | Irrlicht interface to a specific joystick button |
CChLeafspringAxle | Base class for a leaf-spring solid axle suspension |
CChMacPhersonStrut | Base class for a MacPherson strut modeled with bodies and constraints |
CChManualTransmissionShafts | Template for a manual transmission model using shaft elements |
CChMapData | Utility class for reading and setting an (x,y) map |
CChMultiLink | Base class for a multi-link suspension modeled with bodies and constraints |
CChPac02Tire | Pacjeka 02 tire model |
CChPac89Tire | Pacjeka 89 tire model |
CChPart | Base class for a vehicle subsystem |
CChPathFollowerACCDriver | Closed-loop path-follower driver model |
CChPathFollowerDriver | Path-following driver system using a default PID lateral steering controller |
CChPathFollowerDriverPP | Path-following driver system using a lateral steering controller as used on the Pure Pursuit AV |
CChPathFollowerDriverSR | Path-following driver system using a P-like lateral steering controller with variable path prediction |
CChPathFollowerDriverStanley | Path-following driver system using a lateral steering controller as used on the Stanley AV |
CChPathFollowerDriverXT | Path-following driver system using an extended PID lateral steering controller |
CChPathSteeringController | Path-following steering PID controller |
CChPathSteeringControllerPP | "Pure Pursuit" path-following controller This implementation is based on the CARLA Pure Pursuit controller: https://carla.org// https://thomasfermi.github.io/Algorithms-for-Automated-Driving/Control/PurePursuit.html Original algorithm documented at: https://www.ri.cmu.edu/pub_files/pub3/coulter_r_craig_1992_1/coulter_r_craig_1992_1.pdf |
CChPathSteeringControllerSR | Path-following steering P-like controller with variable path prediction |
CChPathSteeringControllerStanley | "Stanley" path-following ontroller named after an autonomous vehicle called Stanley |
CChPathSteeringControllerXT | Path-following steering 3(2) channel PDT1/PT1 controller |
CChPitmanArm | Base class for a Pitman Arm steering subsystem |
CChPitmanArmShafts | Base class for a Pitman Arm steering subsystem with compliant steering column |
CChPowertrainAssembly | Defintion of a powertrain assembly system |
CChPushPipeAxle | Base class for a DeDion solid axle suspension |
CChRackPinion | Base class for a Rack-Pinion steering subsystem |
CChReissnerTire | Tire template for tires based on Reissner shells |
CChRigidChassis | Template for a rigid-body main chassis vehicle subsystem |
CChRigidChassisRear | Template for a rigid-body rear chassis vehicle subsystem |
CChRigidPanhardAxle | Base class for a solid Panhard axle suspension |
CChRigidPinnedAxle | Base class for a rigid suspension with a pinned axle |
CChRigidSuspension | Base class for a rigid suspension, i.e |
CChRigidTire | Rigid tire model |
CChRotaryArm | Base class for a Toe Bar steering subsystem |
CChRotationalDamperSuspension | Base class for a torsion-bar suspension system using a rotational damper (template definition) |
CChSAELeafspringAxle | Base class for a leaf-spring solid axle suspension |
CChSemiTrailingArm | Base class for a semi-trailing arm suspension (non-steerable) |
CChShaftsDriveline2WD | 2WD driveline model template based on ChShaft objects |
CChShaftsDriveline4WD | 4WD driveline model template based on ChShaft objects |
CChShaftsDriveline6WD | 4WD driveline model template based on ChShaft objects |
CChShaftsDriveline8WD | 4WD driveline model template based on ChShaft objects |
CChSimpleDriveline | Simple driveline model |
CChSimpleDrivelineXWD | Simple driveline model |
CChSimpleTrackDriveline | Simple driveline model for a tracked vehicle |
CChSingleTrackWheel | Base class for a single track wheel (template definition) |
CChSingleWishbone | Base class for a double-A arm suspension modeled with bodies and constraints |
CChSolidAxle | Base class for a solid axle suspension modeled with bodies and constraints |
CChSolidBellcrankThreeLinkAxle | Base class for a coil-spring or air-spring solid axle suspension, typically combined with the rotary arm steering |
CChSolidThreeLinkAxle | Base class for a coil-spring or air-spring solid axle suspension |
CChSpeedController | Data collection from the speed controller can be started (restarted) and suspended (stopped) as many times as desired |
CChSprocket | Base class for a tracked vehicle sprocket |
CChSprocketBand | Base class for a sprocket template with gear profile composed of circular arcs and a flat seat |
CChSprocketDoublePin | Base class for a sprocket template with gear profile composed of circular arcs and a flat seat |
CChSprocketSinglePin | Base class for a sprocket template with gear profile composed of circular arcs |
CChSteering | Base class for a steering subsystem |
CChSteeringController | Base class for all steering path-following PID controllers |
CChSubchassis | Base class for a sub-chassis system for wheeled vehicles |
CChSuspension | Base class for a suspension subsystem |
CChSuspensionTestRig | Base class for a suspension test rig |
CChSuspensionTestRigDataDriver | Driver inputs for a suspension test rig from data file |
CChSuspensionTestRigDriver | Base class for a suspension test rig driver system |
CChSuspensionTestRigInteractiveDriverIRR | Irrlicht-based GUI driver for the a suspension test rig |
CChSuspensionTestRigInteractiveDriverVSG | VSG-based GUI driver for the a suspension test rig |
CChSuspensionTestRigPlatform | Definition of a suspension test rig using platforms to actuate the tires |
CChSuspensionTestRigPushrod | Definition of a suspension test rig with direct actuation on the spindle bodies |
►CChTerrain | Base class for a terrain system |
CFrictionFunctor | Class to be used as a functor interface for location-dependent coefficient of friction |
CHeightFunctor | Class to be used as a functor interface for location-dependent terrain height |
CNormalFunctor | Class to be used as a functor interface for location-dependent terrain normal |
CChThreeLinkIRS | Base class for a 3-link independent rear suspension (non-steerable) |
CChTire | Base class for a tire system |
CChTireTestRig | Definition of a single-tire test rig |
CChTMeasyTire | TMeasy handling tire model |
CChTMsimpleTire | TMsimple handling tire model |
CChToeBarDeDionAxle | Base class for a steerable leaf-spring solid axle suspension |
CChToeBarLeafspringAxle | Base class for a steerable leaf-spring solid axle suspension |
CChToeBarPushPipeAxle | Base class for a steerable leaf-spring solid axle suspension |
CChToeBarRigidPanhardAxle | Base class for a steerable solid Panhard axle suspension |
CChTrackAssembly | Definition of a track assembly |
CChTrackAssemblyBand | Definition of a continuous band track assembly |
CChTrackAssemblyBandANCF | Definition of a continuous band track assembly using an ANCFshell-based web A track assembly consists of a sprocket, an idler (with tensioner mechanism), a set of suspensions (road-wheel assemblies), and a collection of track shoes |
CChTrackAssemblyBandBushing | Definition of a continuous band track assembly using a bushing-based web A track assembly consists of a sprocket, an idler (with tensioner mechanism), a set of suspensions (road-wheel assemblies), and a collection of track shoes |
CChTrackAssemblyDoublePin | Definition of a double-pin track assembly |
►CChTrackAssemblySegmented | Base class for segmented track assemblies |
CTrackBendingFunctor | Default torque functor for implementing track bending stiffness |
CChTrackAssemblySinglePin | Definition of a single-pin track assembly |
CChTrackBrake | Base class for a tracked vehicle brake subsystem |
CChTrackBrakeShafts | Brake for tracked vehicles modeled using a clutch between two shafts |
CChTrackBrakeSimple | Simple brake created with constant torque opposing sprocket rotation |
CChTrackContactManager | Class for monitoring contacts of tracked vehicle subsystems |
CChTrackCustomContact | Callback interface for user-defined custom contact between road wheels and track shoes |
CChTrackDrivelineBDS | Track driveline model template based on ChShaft objects |
CChTrackedVehicle | Base class for chrono tracked vehicle systems |
CChTrackedVehicleVisualSystemIrrlicht | Customized Chrono Irrlicht visualization system for tracked vehicle simulation |
CChTrackedVehicleVisualSystemVSG | Customized Chrono::VSG visualization system for tracked vehicle simulation |
CChTrackShoe | Base class for a track shoe |
CChTrackShoeBand | Base class for continuous band track shoes using rigid treads |
CChTrackShoeBandANCF | Base class for a continuous band track shoe using an ANCFshell-based web |
CChTrackShoeBandBushing | Base class for a continuous band track shoe using a bushing-based web |
CChTrackShoeDoublePin | Base class for a double-pin track shoe (template definition) |
CChTrackShoeSegmented | Base class for segmented track shoes |
CChTrackShoeSinglePin | Base class for a single-pin track shoe (template definition) |
►CChTrackSuspension | Base class for a tracked vehicle suspension subsystem |
CForceTorque | Output structure for spring-damper forces or torques |
CChTrackTestRig | Definition of a suspension test rig |
CChTrackTestRigDataDriver | Driver inputs for a track test rig from data file |
CChTrackTestRigDriver | Base class for a track test rig driver system |
CChTrackTestRigInteractiveDriverIRR | Irrlicht-based GUI driver for the a track test rig |
CChTrackTestRigInteractiveDriverVSG | VSG-based GUI driver for the a track test rig |
CChTrackTestRigRoadDriver | Driver inputs for a track test rig based on road profile |
CChTrackTestRigVisualSystemIrrlicht | Customized Chrono Irrlicht application for track test rig visualization |
CChTrackWheel | Base class for a track wheel subsystem |
CChTranslationalDamperSuspension | Base class for a torsion-bar suspension system using linear dampers (template definition) |
CChTranslationalIdler | Base class for an idler subsystem with a translational tensioner |
CChTransmission | Base class for a transmission subsystem |
CChVehicle | Base class for chrono vehicle systems |
CChVehicleBushingData | Stiffness and damping data for a vehicle bushing specification |
►CChVehicleCosimBaseNode | Base class for a co-simulation node |
CMeshContact | Mesh contact information (received from terrain node) |
CMeshState | Mesh state information (sent to terrain node) |
CChVehicleCosimCuriosityNode | Curiosity rover co-simulation node |
CChVehicleCosimDBPRig | Base class for a drawbar-pull rig mechanism |
CChVehicleCosimDBPRigImposedAngVel | Drawbar-pull rig mechanism with imposed angular velocity |
CChVehicleCosimDBPRigImposedSlip | Drawbar-pull rig mechanism with imposed slip |
CChVehicleCosimOtherNode | Definition of an additional MPI node not directly involved in co-simulation |
CChVehicleCosimRigNode | Mechanism for a single-wheel testing rig |
CChVehicleCosimTerrainNode | Base class for a terrain node |
►CChVehicleCosimTerrainNodeChrono | Base class for terrain nodes that use one of the Chrono terrain formulations |
CProxy | Base class for a proxy associated with a co-simulation solid |
CProxyBodySet | Proxy bodies associated with a co-simulation solid |
CProxyMesh | Proxy contact mesh surface associated with a co-simulation solid |
CRigidObstacle | Specification of a rigid obstacle |
CChVehicleCosimTerrainNodeGranularGPU | Definition of the GPU granular terrain node (using Chrono::Gpu) |
CChVehicleCosimTerrainNodeGranularOMP | Definition of the OpenMP granular terrain node (using Chrono::Multicore) |
CChVehicleCosimTerrainNodeGranularSPH | Definition of the SPH continuum representation of granular terrain node (using Chrono::FSI) |
CChVehicleCosimTerrainNodeRigid | Definition of the rigid terrain node (using Chrono::Multicore) |
CChVehicleCosimTerrainNodeSCM | Definition of the SCM deformable terrain node |
CChVehicleCosimTireNode | Base class for all tire nodes |
CChVehicleCosimTireNodeBypass | Definition of the bypass tire node |
CChVehicleCosimTireNodeFlexible | Definition of the flexible tire node |
CChVehicleCosimTireNodeRigid | Definition of the rigid tire node |
CChVehicleCosimTrackedMBSNode | Base class for all MBS nodes with tracks |
CChVehicleCosimTrackedVehicleNode | Tracked vehicle co-simulation node |
CChVehicleCosimViperNode | Viper rover co-simulation node |
CChVehicleCosimWheeledMBSNode | Base class for all MBS nodes with wheels |
CChVehicleCosimWheeledVehicleNode | Wheeled vehicle co-simulation node |
CChVehicleJoint | Wrapper class for a joint in a vehicle system which can be either a kinematic joint or a bushing |
CChVehicleOutput | Base class for a vehicle output database |
CChVehicleOutputASCII | ASCII text vehicle output database |
CChVehicleOutputHDF5 | HDF5 vehicle output database |
CChVehicleVisualSystemIrrlicht | Custom event receiver for chase-cam control |
CChVehicleVisualSystemOpenGL | OpenGL-based Chrono run-time visualization system |
CChVehicleVisualSystemVSG | VSG-based Chrono run-time visualization system |
CChWheel | Base class for a vehicle wheel subsystem |
CChWheeledTrailer | Base class for chrono wheeled trailer systems |
CChWheeledVehicle | Base class for chrono wheeled vehicle systems |
CChWheeledVehicleVisualSystemIrrlicht | Customized Chrono Irrlicht visualization system for wheeled vehicle simulation |
CChWheeledVehicleVisualSystemVSG | Customized Chrono::VSG visualization system for wheeled vehicle simulation |
CChWorldFrame | Definition of the world frame for Chrono::Vehicle simulations |
CCRGTerrain | Concrete class for a (rigid) road loaded from an OpenCRG file |
CCRMTerrain | Continuum representation (CRM) deformable terrain model using SPH |
CDeDionAxle | Leaf-spring solid axle suspension constructed with data from file |
CDegressiveDamperForce | Utility class for specifying a degressive translational damper force |
CDistanceIdler | Distance idler model constructed with data from file (JSON format) |
CDoubleTrackWheel | Double track-wheel model constructed with data from file (JSON format) |
CDoubleWishbone | Double-A arm suspension constructed with data from file |
CDoubleWishboneReduced | Reduced double-A arm suspension constructed with data from file |
CDriverInputs | Driver (vehicle control) inputs |
CEngineShafts | Shafts-based engine subsystem (specified through JSON file) |
CEngineSimple | Simple engine subsystem (specified through JSON file) |
CEngineSimpleMap | Simple speed-torque engine map subsystem (specified through JSON file) |
CFEATerrain | FEA Deformable terrain model |
CFEATire | Co-rotational FEA tire constructed with data from file (JSON format) |
CFialaTire | Fiala tire constructed with data from file (JSON format) |
CFlatTerrain | Concrete class for a flat horizontal terrain |
CGenericWheeledSuspension | Generic wheeled vehicle suspension constructed with data from file |
CGranularTerrain | Granular terrain model |
CHendricksonPRIMAXX | Hendrickson PRIMAXX suspension constructed with data from file |
CLeafspringAxle | Leaf-spring solid axle suspension constructed with data from file |
CLinearDamperForce | Utility class for specifying a linear translational damper force |
CLinearDamperTorque | Utility class for specifying a linear rotational damper torque |
CLinearSpringDamperForce | Utility class for specifying a linear translational spring-damper force with pre-tension |
CLinearSpringDamperTorque | Utility class for specifying a linear rotational spring-damper torque |
CLinearSpringForce | Utility class for specifying a linear translational spring force with pre-tension |
CLinearSpringTorque | Utility class for specifying a linear rotational spring torque |
CMacPhersonStrut | MacPherson strut suspension constructed with data from file |
CManualTransmissionShafts | Shafts-based automatic transmission subsystem (specified through JSON file) |
CMapSpringDamperForce | Utility class for specifying a general nonlinear translational spring-damper force with pre-tension |
CMultiLink | Multi-link suspension constructed with data from file |
CNonlinearDamperForce | Utility class for specifying a nonlinear translational damper force |
CNonlinearDamperTorque | Utility class for specifying a nonlinear rotational damper torque |
CNonlinearSpringDamperForce | Utility class for specifying a nonlinear translational spring-damper force with pre-tension |
CNonlinearSpringDamperTorque | Utility class for specifying a nonlinear rotational spring-damper torque |
CNonlinearSpringForce | Utility class for specifying a nonlinear translational spring force with pre-tension |
CNonlinearSpringTorque | Utility class for specifying a nonlinear rotational spring torque |
CObsModTerrain | Concrete class for a flat horizontal terrain |
CPac02Tire | PAC89 tire model from JSON file |
CPac89Tire | PAC89 tire model from JSON file |
CPitmanArm | Pitman arm steering model constructed with data from file (JSON format) |
CPushPipeAxle | Leaf-spring solid axle suspension constructed with data from file |
CRackPinion | Rack-pinion steering model constructed with data from file (JSON format) |
CRandomSurfaceTerrain | Terrain object representing an uneven area with controlled roughness |
CReissnerTire | Tire with Reissner shells, constructed with data from file (JSON format) |
CRigidChassis | Vehicle rigid chassis model constructed with data from file (JSON format) |
CRigidChassisRear | Vehicle rigid rear chassis model constructed with data from file (JSON format) |
CRigidPanhardAxle | Solid Panhard axle suspension constructed with data from file |
CRigidPinnedAxle | Rigid suspension with pinned axle constructed with data from file |
CRigidSuspension | Rigid suspension constructed with data from file |
►CRigidTerrain | Rigid terrain model |
CPatch | Definition of a patch in a rigid terrain model |
CRigidTire | Rigid tire constructed with data from file (JSON format) |
CRotaryArm | RotaryArm-pinion steering model constructed with data from file (JSON format) |
CRotationalDamperSuspension | Torsion-bar suspension system using linear dampers constructed with data from file (JSON format) |
CSAELeafspringAxle | Leaf-spring solid axle suspension constructed with data from file |
CSAEToeBarLeafspringAxle | Steerable leaf-spring solid axle suspension constructed with data from file |
CSCMContactableData | Parameters for soil-contactable interaction |
CSCMLoader | Underlying implementation of the Soil Contact Model |
►CSCMTerrain | Deformable terrain model |
CNodeInfo | Information at SCM node |
CSoilParametersCallback | Class to be used as a callback interface for location-dependent soil parameters |
CSemiTrailingArm | Semi-trailing arm suspension constructed with data from file |
CShaftsDriveline2WD | 2WD driveline model template based on ChShaft objects using data from file (JSON format) |
CShaftsDriveline4WD | 4WD driveline model template based on ChShaft objects using data from file (JSON format) |
CSimpleDriveline | Simple driveline model template using data from file (JSON format) |
CSimpleDrivelineXWD | Simple driveline model template using data from file (JSON format) |
CSimpleTrackDriveline | Simple tracked vehicle driveline model template using data from file (JSON format) |
CSingleTrackWheel | Single track-wheel model constructed with data from file (JSON format) |
CSingleWishbone | Single A-arm suspension constructed with data from file |
CSolidAxle | Solid axle suspension constructed with data from file |
CSolidBellcrankThreeLinkAxle | Solid axle suspension constructed with data from file |
CSolidThreeLinkAxle | Leaf-spring solid axle suspension constructed with data from file |
CSpringForce | Base class for linear and nonlinear translational spring forces |
CSprocketBand | Tracked vehicle continuous-band sprocket model constructed with data from file (JSON format) |
CSprocketDoublePin | Tracked vehicle double-pin sprocket model constructed with data from file (JSON format) |
CSprocketSinglePin | Tracked vehicle single-pin sprocket model constructed with data from file (JSON format) |
CTerrainForce | Structure to communicate a set of generalized terrain contact forces (tire or track shoe) |
CThreeLinkIRS | Three-link Independent Rear Suspension constructed with data from file |
CTMeasyTire | TMeasy tire constructed with data from file (JSON format) |
CTMsimpleTire | TMeasy tire constructed with data from file (JSON format) |
CToeBarDeDionAxle | Steerable leaf-spring solid axle suspension constructed with data from file |
CToeBarLeafspringAxle | Steerable leaf-spring solid axle suspension constructed with data from file |
CToeBarPushPipeAxle | Steerable leaf-spring solid axle suspension constructed with data from file |
CToeBarRigidPanhardAxle | Steerable leaf-spring solid axle suspension constructed with data from file |
CTrackAssemblyBandANCF | Band-ANCF track assembly model constructed from a JSON specification file |
CTrackAssemblyBandBushing | Band-bushing track assembly model constructed from a JSON specification file |
CTrackAssemblyDoublePin | Double-pin track assembly model constructed from a JSON specification file |
CTrackAssemblySinglePin | Single-pin track assembly model constructed from a JSON specification file |
CTrackBrakeShafts | Tracked vehicle shafts-based brake model constructed with data from file (JSON format) |
CTrackBrakeSimple | Tracked vehicle simple brake model constructed with data from file (JSON format) |
CTrackDrivelineBDS | BDS tracked vehicle driveline model template using data from file (JSON format) |
CTrackedVehicle | Tracked vehicle model constructed from a JSON specification file |
CTrackShoeBandANCF | Band-ANCF track shoe with central guide constructed with data from file (JSON format) |
CTrackShoeBandBushing | Band-bushing track shoe with central guide constructed with data from file (JSON format) |
CTrackShoeDoublePin | Double-pin track shoe with central guide constructed with data from file (JSON format) |
CTrackShoeSinglePin | Single-pin track shoe with central guide constructed with data from file (JSON format) |
CTranslationalDamperSuspension | Torsion-bar suspension system using linear dampers constructed with data from file (JSON format) |
CTranslationalIdler | Translational idler model constructed with data from file (JSON format) |
CWheel | Vehicle wheel constructed with data from file (JSON format) |
CWheeledTrailer | Wheeled trailer model constructed from a JSON specification file |
CWheeledVehicle | Wheeled vehicle model constructed from a JSON specification file |
CWheelState | Structure to communicate a full wheel body state |
►Nviper | Namespace with classes for the Viper model |
CViper | Viper rover class |
CViperChassis | Viper rover Chassis |
CViperDCMotorControl | Concrete Viper driver class for a simple DC motor control |
CViperDriver | Base class definition for a Viper driver |
CViperLowerArm | The bottom arm of the Viper rover suspension |
CViperPart | Base class definition for all Viper parts |
CViperSpeedDriver | Concrete Viper speed driver |
CViperUpperArm | The upper arm of the Viper rover suspension |
CViperUpright | Steering rod of the Viper rover |
CViperWheel | Viper rover Wheel |
►Nvsg3d | Namespace with classes for the VSG module |
CChEventHandlerVSG | Base class for a user-defined event handler for the VSG run-time visualization system |
CChGuiComponentVSG | Base class for a GUI component for the VSG run-time visualization system |
►CChVisualSystemVSG | VSG-based Chrono run-time visualization system |
CDeformableMesh | Data related to deformable meshes (FEA and SCM) |
CParticleCloud | Data for particle clouds |
CAngleAxis | Representation of a rotation as angle-axis |
CAngleSet | Representation of an Euler/Cardan angle set |
CcbtArcArcCollisionAlgorithm | Custom override of the default Bullet algorithm for 2Darc-2Darc collision |
CcbtArcSegmentCollisionAlgorithm | Custom override of the default Bullet algorithm for 2Dsegment-2Darc collision |
CcbtCapsuleBoxCollisionAlgorithm | Custom override of the default Bullet algorithm for capsule-box collision |
CcbtCEtriangleShapeCollisionAlgorithm | Custom override of the default Bullet algorithm for triangle-triangle collision |
CcbtCylshellBoxCollisionAlgorithm | Custom override of the default Bullet algorithm for cylshell-box collision |
CcbtSegmentSegmentCollisionAlgorithm | Custom override of the default Bullet algorithm for segment-segment collision |
CcbtSphereCylinderCollisionAlgorithm | Custom override of the default Bullet algorithm for sphere-cylinder collision |
CcbtVector3CH | Utility class to convert a Chrono ChVector3d into a Bullet vector3 |
CCh3DOFContainer | Base class for containers of elements with 3 degrees of freedom (fluid nodes, rigid particles) |
CChAABB | Axis-aligned bounding box |
CChArchive | Base class for archives with pointers to shared objects |
CChArchiveIn | Base class for deserializing from archives |
CChArchiveInBinary | Deserialization from binary stream |
CChArchiveInJSON | This is a class for deserializing from JSON archives |
CChArchiveInXML | This is a class for deserializing from XML archives |
CChArchiveOut | Base class for serializing into archives |
CChArchiveOutBinary | Serialization to binary stream |
CChArchiveOutJSON | Serialize objects using JSON format |
CChArchiveOutXML | Serialize objects using JSON format |
CChAssembly | Class for assemblies of physical items |
CChAssemblyAnalysis | Class for assembly analysis |
CChBasisToolsBSpline | Tools for evaluating basis functions for B-splines, parametrized with parameter u (as lines) These bases are often called "N" in literature |
CChBasisToolsBSplineSurfaces | Tools for evaluating basis functions for tensor-product surface B-splines, parametrized with parameters u,v (as lines) These bases are often called "R" in literature |
CChBasisToolsNurbs | Tools for evaluating basis functions for NURBS, parametrized with parameter u (as lines) These bases are often called "R" in literature |
CChBasisToolsNurbsSurfaces | Tools for evaluating basis functions for tensor-product surface NURBS, parametrized with parameter u,v (as lines) These bases are often called "R" in literature |
CChBezierCurve | Definition of a piece-wise cubic Bezier approximation of a 3D curve |
CChBezierCurveTracker | Definition of a tracker on a ChBezierCurve path |
CChBody | Class for Rigid Bodies |
CChBodyAuxRef | Class for Rigid Bodies with an auxiliary Reference Frame |
CChBodyEasyBox | Create rigid bodies with a box shape |
CChBodyEasyClusterOfSpheres | Create rigid bodies with a shape made of a cluster of spheres |
CChBodyEasyConvexHull | Create rigid bodies with a convex hull shape |
CChBodyEasyConvexHullAuxRef | Create rigid body with a convex hull shape, with a reference frame distinct from the centroidal frame |
CChBodyEasyCylinder | Create rigid bodies with a cylinder shape |
CChBodyEasyEllipsoid | Create rigid bodies with an ellipsoid shape |
CChBodyEasyMesh | Create rigid bodies with a mesh shape, with a reference frame distinct from the centroidal frame |
CChBodyEasySphere | Create rigid bodies with a spherical shape |
CChBodyFrame | Class for objects that represent moving frames in space and contain state variables |
CChBox | A box geometric object for collisions and visualization |
CChBroadphase | Class for performing broad-phase collision detection |
CChCamera | Class for defining a camera point of view with basic settings |
CChCapsule | A capsule geometric object for collision and visualization |
CChCastingMap | Stores type-casting functions between different type pairs, allowing to pick them at runtime from std::type_index or classname Converting pointers between different classes is usually possible by standard type casting, given that the source and destination class types are known at compile time. This class allows to typecast between class types that are known only at runtime. The requirement is that the typecasting function has to be prepared in advance (i.e. at compile time), when the types are still known. For each potential conversion an instance of ChCastingMap has to be declared, together with its typecasting function. This procedure is simplified by the macros CH_UPCASTING(FROM, TO) and CH_UPCASTING_SANITIZED(FROM, TO, UNIQUETAG) When the conversion should take place the following can be called: ConversionMap::Convert(std::string("source_classname"), std::string("destination_classname"), <void* to object>) |
CChClassFactory | A class factory |
CChClassRegistration | Macro to create a ChDetect_ArchiveInConstructor |
CChClassRegistrationBase | Base class for all registration data of classes whose objects can be created via a class factory |
CChCLI | Wrapper for cxxopts |
CChCollisionData | Global data for the custom Chrono multicore collision system |
CChCollisionInfo | Class defining basic geometric information for collision pairs |
CChCollisionModel | Class defining the geometric model for collision detection |
CChCollisionModelBullet | Class defining the Bullet geometric model for collision detection |
CChCollisionModelMulticore | Geometric model for the custom multicore Chrono collision system |
CChCollisionPair | Class for storing information about a collision point |
CChCollisionShape | Class defining a collision shape |
CChCollisionShapeArc2D | Collision 2D arc shape |
CChCollisionShapeBarrel | Collision barrel shape |
CChCollisionShapeBox | Collision box shape |
CChCollisionShapeCapsule | Collision capsule shape |
CChCollisionShapeCone | Collision cone shape |
CChCollisionShapeConvexHull | Collision convex hull shape |
CChCollisionShapeCylinder | Collision cylinder shape |
CChCollisionShapeCylindricalShell | Collision cylindrical shell shape |
CChCollisionShapeEllipsoid | Collision ellipsoid shape |
CChCollisionShapeMeshTriangle | Collision shape representing a triangle in a connected mesh |
CChCollisionShapePath2D | Collision 2D path shape |
CChCollisionShapePoint | Collision point shape |
CChCollisionShapeRoundedBox | Collision rounded-box shape |
CChCollisionShapeRoundedCylinder | Collision rounded-cylinder shape |
CChCollisionShapeSegment | Collision segment shape |
CChCollisionShapeSegment2D | Collision 2D segment shape |
CChCollisionShapeSphere | Collision sphere shape |
CChCollisionShapeTriangle | Collision triangle shape |
CChCollisionShapeTriangleMesh | Collision mesh shape |
►CChCollisionSystem | Base class for generic collision engine |
CBroadphaseCallback | Class to be used as a callback interface for user-defined actions to be performed for each 'near enough' pair of collision shapes found by the broad-phase collision step |
CChRayhitResult | Recover results from RayHit() raycasting |
CNarrowphaseCallback | Class to be used as a callback interface for user-defined actions to be performed at each collision pair found during the narrow-phase collision step |
CVisualizationCallback | Class to be used as a callback interface for user-defined visualization of collision shapes |
CChCollisionSystemBullet | Collision engine based on the Bullet library |
CChCollisionSystemChronoMulticore | Chrono custom multicore collision system |
CChCollisionSystemMulticore | Chrono multicore collision system |
CChColor | Definition of a visual color |
CChCone | A conical geometric object for collisions and visualization |
CChConstantDistribution | Class for a distribution with a single 'value' that has probability 1.0 |
CChConstraint | Base class for representing constraints (bilateral or unilateral) |
CChConstraintBilateral | Bilateral (joint) constraints |
CChConstraintNgeneric | Constraint between N objects of type ChVariables() |
CChConstraintRigidRigid | Unilateral (contact) constraints |
CChConstraintThree | This class is inherited by the base ChConstraint(), which does almost nothing |
CChConstraintThreeBBShaft | Constraint between two bodies (2x6dof in space) and a 1D dof (a shaft) |
CChConstraintThreeGeneric | Constraint between three objects of type ChVariables(), with generic number of scalar variables each |
CChConstraintTuple_1vars | This is a container for 'half' of a constraint, and contains a tuple of 1 or 2 or 3 differently-sized jacobian chunks |
CChConstraintTuple_2vars | Case of tuple with reference to 2 ChVariable objects: |
CChConstraintTuple_3vars | Case of tuple with reference to 3 ChVariable objects: |
CChConstraintTuple_4vars | Case of tuple with reference to 4 ChVariable objects: |
CChConstraintTwo | This class implements the functionality for a constraint between a COUPLE of TWO objects of type ChVariables(), and defines two constraint matrices, whose column number automatically matches the number of elements in variables vectors |
CChConstraintTwoBodies | Constraint between two objects of type ChVariablesBody |
CChConstraintTwoGeneric | This class implements the functionality for a constraint between a COUPLE of TWO objects of type ChVariables(), with generic number of scalar variables each (ex.ChVariablesGeneric() or ChVariablesBody() ) and defines two constraint matrices, whose column number automatically matches the number of elements in variables vectors |
CChConstraintTwoGenericBoxed | This class is inherited from the base ChConstraintTwoGeneric, which can be used for most pairwise constraints, and adds the feature that the multiplier must be l_min < l < l_max that is, the multiplier is 'boxed' |
CChConstraintTwoTuples | This constraint is built on top of two ChConstraintTuple objects, each with a tuple of 1 or 2 or 3 differently-sized jacobian chunks |
CChConstraintTwoTuplesContactN | Normal reaction between two objects, each represented by a tuple of ChVariables objects |
CChConstraintTwoTuplesFrictionT | Base class for friction constraints between two objects, each represented by a tuple of ChVariables objects |
CChConstraintTwoTuplesFrictionTall | This is enough to use dynamic_casting<> to detect all template types from ChConstraintTwoTuplesFrictionT |
CChConstraintTwoTuplesRollingN | Normal reaction between two objects, each represented by a tuple of ChVariables objects |
CChConstraintTwoTuplesRollingNall | This is enough to use dynamic_casting<> to detect all template types from ChConstraintTwoTuplesRollingN |
CChConstraintTwoTuplesRollingT | Base class for friction constraints between two objects, each represented by a tuple of ChVariables objects |
CChConstraintTwoTuplesRollingTall | This is enough to use dynamic_casting<> to detect all template types from ChConstraintTwoTuplesRollingT |
CChContactable | Interface for objects that generate contacts |
►CChContactContainer | Class representing a container of many contacts |
CAddContactCallback | Class to be used as a callback interface for some user defined action to be taken each time a contact is added to the container |
CReportContactCallback | Class to be used as a callback interface for some user defined action to be taken for each contact (already added to the container, maybe with already computed forces) |
CChContactContainerMulticore | Class representing a container of many contacts, implemented as a linked list of contact tuples |
CChContactContainerMulticoreNSC | Specialization of the multicore contact container for NSC contacts |
CChContactContainerMulticoreSMC | Specialization of the multicore contact container for SMC contacts |
►CChContactContainerNSC | Class representing a container of many non-smooth contacts |
CReportContactCallbackNSC | Class to be used as a NSC-specific callback interface for some user defined action to be taken for each contact (already added to the container, maybe with already computed forces) |
CChContactContainerSMC | Class representing a container of many smooth (penalty) contacts |
CChContactMaterial | Base class for specifying material properties for contact force generation |
CChContactMaterialComposite | Base class for composite material for a contact pair |
CChContactMaterialCompositeNSC | Composite NSC material data for a contact pair |
CChContactMaterialCompositeSMC | Composite SMC material data for a contact pair |
CChContactMaterialCompositionStrategy | Base class for material composition strategy |
CChContactMaterialData | Material information for a collision shape |
CChContactMaterialNSC | Material data for a collision surface for use with non-smooth (complementarity) contact method |
CChContactMaterialSMC | Material data for a collision surface for use with smooth (penalty) contact method |
CChContactNSC | Class for non-smooth contact between two generic ChContactable objects |
CChContactNSCrolling | Class for non-smooth contact between two generic ChContactable objects |
CChContactSMC | Class for smooth (penalty-based) contact between two generic contactable objects |
CChContactTuple | Base class for contact between two generic ChContactable objects |
CChContinuumDistribution | Class that can be used to generate sample numbers according to a probability distribution |
CChConvexDecomposition | Base interface class for convex decomposition |
CChConvexDecompositionHACD | Class for wrapping the HACD convex decomposition code by Khaled Mamou |
CChConvexDecompositionHACDv2 | Class for wrapping the HACD convex decomposition code revisited by John Ratcliff |
CChConveyor | Class for conveyor belt |
CChCoordsys | Representation of a transform with translation and rotation |
CChCubicSpline | Implementation of 1-D piece-wise cubic spline curves |
CChCylinder | A cylindrical geometric object for collisions and visualization |
CChDefaultContactForceTorqueSMC | Default implementation of the SMC normal and tangential force calculation |
CChDirectSolverLS | Base class for sparse direct linear solvers |
CChDirectSolverLScomplex | Base class for sparse direct linear solvers with complex coefficients |
CChDiscreteDistribution | Class that can be used to generate sample numbers according to a discrete probability distribution |
CChDistribution | Base class for all random distributions |
CChEllipsoid | An ellipsoid geometric object for collisions and such |
CChEnumMapperBase | Class for mapping enums to ChNameValue pairs that contain a 'readable' ascii string of the selected enum |
CChExplicitTimestepper | Base properties for explicit solvers |
CChExternalDynamicsDAE | Physics element that carries its own dynamics, described as an index-3 DAE IVP of the form: |
CChExternalDynamicsODE | Physics element that carries its own dynamics, described as an ODE IVP of the form: |
CChExternalFmu | Chrono physics item that wraps a model exchange FMU |
CChFeeder | Class for feeders like vibrating bowls, conveyor belts |
CChFluidContainer | Container of fluid particles |
CChFmMatrix34 | Special MBD 3x4 matrix [Fm(q)], as in [Fp(q)] * [Fm(q)]' = [A(q)] |
CChFmuWrapper | Abstract interface to a model exchange FMU |
CChForce | Forces are objects which must be attached to rigid bodies in order to apply torque or force to such body |
CChFpMatrix34 | Special MBD 3x4 matrix [Fp(q)], as in [Fp(q)] * [Fm(q)]' = [A(q)] |
CChFrame | Representation of a 3D transform |
CChFrameMoving | Representation of a moving 3D |
CChFseqNode | Node for the list of functions in a ChFunctionSequence object |
CChFunction | Interface base class for scalar functions |
CChFunctionBSpline | B-Spline motion function |
CChFunctionConst | Function returnin a constant value |
CChFunctionConstAcc | Constant acceleration function |
CChFunctionConstJerk | Ramp function composed by seven segments with constant jerk |
CChFunctionCycloidal | Cycloidal step function |
CChFunctionDerivative | Derivative of a function |
CChFunctionFillet3 | Cubic fillet function |
CChFunctionIntegral | Integral of a function |
CChFunctionInterp | Interpolation function |
CChFunctionLambda | Lambda function wrapper Allows the usage of C++ lambda functions as ChFunction objects |
CChFunctionMirror | Mirror function |
CChFunctionOperator | Operation between functions: |
CChFunctionPoly | Polynomial function |
CChFunctionPoly23 | Cubic smooth step |
CChFunctionPoly345 | Polynomial step function y = h * (10*(x/w)^3 - 15*(x/w)^4 + 6*(x/w)^5) where: |
CChFunctionPosition | Interface base class for scalar->vector functions |
CChFunctionPositionLine | A motion function p=f(s) where p(t) is defined with a ChLine geometry object, ex |
CChFunctionPositionSetpoint | A motion function p=f(s) where p(t) is an externally-provided sample, as a ZERO_ORDER_HOLD (zero order hold) of FIRST_ORDER_HOLD (first order) |
CChFunctionPositionXYZFunctions | A motion function p=f(s) where p(t) is defined with three independent ChFunction objects, each for px, py, pz component |
CChFunctionRamp | Ramp function |
CChFunctionRepeat | Repeat function: y = __/__/__/ |
CChFunctionRotation | Interface base class for scalar->quaternion functions of the type: |
CChFunctionRotationABCFunctions | A rotation function q=f(s) where q(s) is defined with three ChFunction objects, each per an an angle in an intrinsic triplets of angles (e.g |
CChFunctionRotationAxis | A rotation function q=f(s) where q(s) is defined with axis V and angle alpha, assuming fixed axis of rotation V and a angle of rotation alpha about that axis, expressed with a ChFunction object alpha=alpha(s) |
CChFunctionRotationBSpline | A rotation function q=f(s) that interpolates n rotations using a "quaternion B-Spline" of generic order |
CChFunctionRotationSetpoint | A rotation q=f(s) provided from a rotation sample, continuously updated by the user, behaving as a ZERO_ORDER_HOLD (zero order hold) of FIRST_ORDER_HOLD (first order) |
CChFunctionRotationSQUAD | A rotation function q=f(s) that interpolates n rotations using a SQUAD spherical quadrangle interpolation between quaternions |
CChFunctionSequence | Sequence function: y = sequence_of_functions(f1(y), f2(y), f3(y)) All other function types can be inserted into this |
CChFunctionSetpoint | Function that returns Y from an externally-provided value, as a ZERO_ORDER_HOLD (zero order hold) block |
CChFunctionSetpointCallback | Interface for functions that uses a callback to return a Y value, as a ZERO_ORDER_HOLD (zero order hold) block |
CChFunctionSine | Sine function y = A*sin(2*PI*f + phase)` |
CChFunctionSineStep | Sinusoidal ramp between two (x,y) points p1 and p2 |
CChFunctorArchiveIn | Functor to call the ArchiveIn function for unrelated classes that implemented them |
CChGeometry | Base class for geometric objects used for collisions and visualization |
CChGlMatrix34 | Special MBD 3x4 matrix [Gl(q)], as in local angular speed conversion |
CChGlyphs | Class for referencing a set of 'glyphs', that are simple symbols such as arrows or points to be drawn for showing vector directions etc |
CChGwMatrix34 | Special MBD 3x4 matrix [Gw(q)], as in absolute angular speed conversion |
CChHydraulicActuator2 | Hydraulic actuator using a circuit with 2 volumes |
CChHydraulicActuator3 | Hydraulic actuator using a circuit with 3 volumes |
CChHydraulicActuatorBase | Base class for a hydraulic actuator |
CChHydraulicCylinder | ChHydraulicCylinder - a simple hydraulic cylinder Schematic: |
CChHydraulicDirectionalValve4x3 | ChHydraulicDirectionalValve4x3 - a computational model of 4/3 directional valve Schematic: |
CChHydraulicThrottleValve | ChHydraulicThrottleValve - a semi-empirical model of a throttle valve Schematic: |
CChImplicitIterativeTimestepper | Base properties for implicit solvers |
CChImplicitTimestepper | Base class for implicit solvers (double inheritance) |
CChIndexedNodes | Interface class for clusters of points that can be accessed with an index |
CChIndexedParticles | Interface class for clusters of particles that can be accessed with an index |
CChInertiaUtils | Class with some static functions that can be used to make computations with inertia tensors |
CChIntegrable | Interface class for all objects that support time integration |
CChIntegrableIIorder | Special subcase: II-order differential system |
CChIntegrand1D | Base class for 1D integrand T = f(x) to be used in ChQuadrature |
CChIntegrand2D | Base class for 2D integrand T = f(x,y) to be used in ChQuadrature |
CChIntegrand3D | Base class for 3D integrand T = f(x,y,z) to be used in ChQuadrature |
CChIterativeSolver | Base class for iterative solvers |
CChIterativeSolverLS | Base class for Chrono solvers based on Eigen iterative linear solvers |
CChIterativeSolverMulticore | Base class for all iterative solvers |
CChIterativeSolverMulticoreNSC | Wrapper class for all complementarity solvers |
CChIterativeSolverMulticoreSMC | Iterative solver for SMC (penalty-based) problems |
CChIterativeSolverVI | Base class for iterative solvers aimed at solving complementarity problems arising from QP optimization problems |
CChKRMBlock | Sparse blocks loaded into the KRM global matrix, associated with a set of variables |
CChLine | Base class for all geometric objects representing lines in 3D space |
CChLineArc | Geometric object representing an arc or a circle in 3D space |
CChLineBezier | Geometric object representing a piecewise cubic Bezier curve in 3D |
CChLineBSpline | Geometric object representing a Bspline spline |
CChLineCam | Geometric object describing the profile of a cam |
CChLineNurbs | Geometric object representing a NURBS spline |
CChLinePath | Geometric object representing an sequence of other ChLine objects, The ChLine objects are assumed to be properly concatenated and to have C0 continuity |
CChLinePoly | Geometric object representing a polygonal line in 3D space, controlled by control points |
CChLineSegment | Geometric object representing a segment in 3D space with two end points |
CChLink | Base class for joints between two ChBodyFrame objects |
CChLinkBase | Base class for all types of constraints in the 3D space |
CChLinkBushing | Link with up to 6-degree-of-freedom linear compliance between rigid bodies |
CChLinkDistance | Fixed distance constraint between two points on two ChBodyFrame objects |
CChLinkForce | Class for forces in link joints of type ChLinkLock |
CChLinkLimit | Class for limits in ChLinkLock joints |
CChLinkLock | Base class for joints implemented using the "lock" formulation |
CChLinkLockAlign | Align joint, with the 'ChLinkLock' formulation |
CChLinkLockBrake | Link representing a brake between two rigid bodies, including the sticking effect |
CChLinkLockClearance | A class for the custom fast simulation of revolute joints with clearance |
CChLinkLockCylindrical | Cylindrical joint, with the 'ChLinkLock' formulation |
CChLinkLockFree | Free joint, with the 'ChLinkLock' formulation |
CChLinkLockGear | Gear link between two rigid bodies |
CChLinkLockLinActuator | Linear actuator between two markers on two rigid bodies The distance between the two markers changes in time following a user-provided function |
CChLinkLockLock | 6-dof locked joint, with the link-lock formulation |
CChLinkLockOldham | Oldham joint, with the 'ChLinkLock' formulation |
CChLinkLockParallel | Parallel joint, with the 'ChLinkLock' formulation |
CChLinkLockPerpend | Perpendicularity joint, with the 'ChLinkLock' formulation |
CChLinkLockPlanar | Plane-plane joint, with the 'ChLinkLock' formulation |
CChLinkLockPointLine | Point-line joint, with the 'ChLinkLock' formulation |
CChLinkLockPointPlane | Point-plane joint, with the 'ChLinkLock' formulation |
CChLinkLockPointSpline | ChLinkLockPointSpline class |
CChLinkLockPrismatic | Prismatic joint, with the 'ChLinkLock' formulation |
CChLinkLockPulley | Class to create pulleys on two rigid bodies, connected by a belt |
CChLinkLockRevolute | Revolute joint, with the 'ChLinkLock' formulation |
CChLinkLockRevolutePrismatic | RevolutePrismatic joint, with the 'ChLinkLock' formulation |
CChLinkLockScrew | Screw joint between two rigid bodies |
CChLinkLockSpherical | Spherical joint, with the 'ChLinkLock' formulation |
CChLinkLockTrajectory | ChLinkLockTrajectory class |
CChLinkMarkers | Class for links which connect two 'markers' |
CChLinkMask | Mask structure for N scalar constraint equations between two bodies |
CChLinkMaskLF | Specialized ChLinkMask class, for constraint equations of the ChLinkLock link |
CChLinkMate | Base class for constraints between two frames attached to two bodies |
CChLinkMateCylindrical | Mate constraint of coaxial type |
CChLinkMateDistanceZ | Mate constraining distance of origin of frame 2 respect to Z axis of frame 1 |
CChLinkMateFix | Mate constraint to completely fix relative motion of two frames |
CChLinkMateGeneric | Generic mate constraint |
CChLinkMateOrthogonal | Mate constraint of orthogonal type |
CChLinkMateParallel | Mate constraint of parallel type |
CChLinkMatePlanar | Mate constraint of plane-to-plane type |
CChLinkMatePrismatic | Mate constraint of prismatic type |
CChLinkMateRackPinion | Rack-pinion link between two body frames |
CChLinkMateRevolute | Mate constraint of revolute type |
CChLinkMateSpherical | Mate constraint of spherical type |
CChLinkMotionImposed | A joint to enforce position and rotation between two frames on two bodies, using six rheonomic constraints |
CChLinkMotor | Base class for all "motor" constraints between two frames on two bodies |
CChLinkMotorLinear | Base class for all linear "motor" constraints between two frames on two bodies |
CChLinkMotorLinearDriveline | Couples the relative translation of two bodies (along Z direction of the link frames) with the rotation of a 1D shaft |
CChLinkMotorLinearForce | A linear motor that applies a force between two frames on two bodies along Z axis |
CChLinkMotorLinearPosition | A linear motor that enforces the position z(t) between two frames on two bodies, using a rheonomic constraint |
CChLinkMotorLinearSpeed | A linear motor that enforces the speed v(t) between two frames on two bodies, using a rheonomic constraint |
CChLinkMotorRotation | Base class for all rotational "motor" constraints between two frames on two bodies |
CChLinkMotorRotationAngle | A motor that enforces the rotation angle r(t) between two frames on two bodies, using a rheonomic constraint |
CChLinkMotorRotationDriveline | Couple for the relative rotation of two bodies (along the link frame Z direction) with the rotation of a 1D shaft |
CChLinkMotorRotationSpeed | A motor that enforces the angular speed w(t) between two frames on two bodies, using a rheonomic constraint |
CChLinkMotorRotationTorque | A motor that applies a torque between two frames on two bodies |
CChLinkRevolute | Class for modeling a revolute joint between two two ChBodyFrame objects |
CChLinkRevoluteSpherical | Composite revolute-spherical joint between two two bodies |
CChLinkRevoluteTranslational | Class for modeling a composite revolute-translational joint between two ChBodyFrame objects |
►CChLinkRSDA | Class for rotational spring-damper-actuator (RSDA) with the torque specified through a functor object |
CTorqueFunctor | Class to be used as a callback interface for calculating the general spring-damper torque |
►CChLinkTSDA | Class for translational spring-damper-actuator (TSDA) with the force optionally specified through a functor object |
CForceFunctor | Class to be used as a callback interface for calculating the general spring-damper force |
CODE | Class to be used as a callback interface for specifying the ODE, y' = f(t,y); y(0) = y0 |
CChLinkUniversal | Class for modeling a universal joint between two two ChBodyFrame objects |
CChLoad | Load acting on a single ChLoadable item, via ChLoader objects |
CChLoadable | Interface for objects that can be subject to loads (forces) Forces can be distributed on UV surfaces, or lines, etc.,so look also the more detailed children classes |
CChLoadableU | Interface for objects that can be subject to line loads, distributed along U coordinate of the object |
CChLoadableUV | Interface for objects that can be subject to area loads, distributed along UV coordinates of the object |
CChLoadableUVW | Interface for objects that can be subject to volume loads, distributed along UVW coordinates of the object |
CChLoadBase | Base class for loads |
CChLoadBodyBody | Base class for wrench loads (a force + a torque) acting between two bodies |
CChLoadBodyBodyBushingGeneric | Load for a visco-elastic translational/rotational bushing acting between two bodies |
CChLoadBodyBodyBushingMate | Load for a visco-elastic translational/rotational bushing acting between two bodies |
CChLoadBodyBodyBushingPlastic | Load for a visco-elasto-plastic bushing acting between two bodies |
CChLoadBodyBodyBushingSpherical | Load for a visco-elastic bushing acting between two bodies |
CChLoadBodyBodyTorque | Load representing a torque applied between two bodies |
CChLoadBodyForce | Load representing a concentrated force acting on a rigid body |
CChLoadBodyInertia | Load for adding mass and inertia to a body |
CChLoadBodyMesh | Loads applied to a triangle mesh associated with a ChBody, as a cluster of forces operating on the rigid body |
CChLoadBodyTorque | Load representing a torque applied to a rigid body |
CChLoadContainer | A container of ChLoad objects |
CChLoadCustom | Loads acting on a single ChLoadable item |
CChLoadCustomMultiple | Loads acting on multiple ChLoadable items |
CChLoader | Loads applied to a single ChLoadable object |
CChLoaderForceOnSurface | Simple surface loader: a constant force vector, applied to a point on a u,v surface |
CChLoaderGravity | Commonly used volume loader: constant gravitational load |
CChLoaderNodeXYZ | Loader for a constant force applied at a XYZ node |
CChLoaderPressure | Commonly used surface loader: constant pressure load, a 3D per-area force aligned with the surface normal |
CChLoaderU | Loaders for ChLoadableU objects (which support line loads) |
CChLoaderUatomic | Loader for ChLoadableU objects (which support line loads), for concentrated loads |
CChLoaderUdistributed | Loader for ChLoadableU objects (which support line loads), for loads of distributed type |
CChLoaderUV | Loaders for ChLoadableUV objects (which support surface loads) |
CChLoaderUVatomic | Loaders for ChLoadableUV objects (which support surface loads), for concentrated loads |
CChLoaderUVdistributed | Loaders for ChLoadableUV objects (which support surface loads), for loads of distributed type |
CChLoaderUVW | Loaders for ChLoadableUVW objects (which support volume loads) |
CChLoaderUVWatomic | Loaders for ChLoadableUVW objects (which support volume loads), for concentrated loads |
CChLoaderUVWdistributed | Loaders for ChLoadableUVW objects (which support volume loads), for loads of distributed type |
CChLoadJacobians | Utility class for storing Jacobian matrices |
CChLoadNodeXYZ | Force at XYZ node (ready to use load) |
CChLoadNodeXYZBody | Base class for loads representing a concentrated force acting between a ChNodeXYZ and a ChBody Users should inherit from this and implement a custom ComputeForce() |
CChLoadNodeXYZBodyBushing | Load representing a XYZ bushing between a ChNodeXYZ and a ChBody application point, with given with spring stiffness as a ChFunction of displacement, for each X,Y,Z direction along the auxiliary frame at the attachment point |
CChLoadNodeXYZBodySpring | Load representing a spring between a ChNodeXYZ and a ChBody |
CChLoadNodeXYZForce | Base class for loads representing a concentrated force acting on a ChNodeXYZ |
CChLoadNodeXYZForceAbs | Load representing a concentrated force acting on a ChNodeXYZ |
CChLoadNodeXYZNodeXYZ | Base class for loads representing a concentrated force acting between two ChNodeXYZ |
CChLoadNodeXYZNodeXYZBushing | Load representing an XYZ bushing between two ChNodeXYZ |
CChLoadNodeXYZNodeXYZSpring | Load representing a spring between two ChNodeXYZ |
CChLumpingParms | Helper class for lumping parameters |
CChMarker | Markers are auxiliary reference frames attached to a rigid body and moving with the body |
CChMatlabEngine | Class for accessing the Matlab engine with a C++ wrapper |
CChMatrix33 | Definition of a 3x3 fixed-size matrix to represent 3D rotations and inertia tensors |
CChMulticoreDataManager | Global data manager for Chrono::Multicore |
CChMumpsEngine | Wrapper class for the MUMPS direct linear solver |
CChNameValue | Class to manage name-value pairs for serialization/deserialization |
CChNarrowphase | Class for performing narrowphase collision detection |
CChNodeBase | Class for a node, that has some degrees of freedom |
CChNodeXYZ | Class for a single 'point' node, that has 3 DOF degrees of freedom and a mass |
CChNonlinearSolver | Solver for systems of nonlinear equations |
CChNormalDistribution | Class that generates the Gauss Normal distribution (the 'bell' distribution) |
CChObj | Base class for all Chrono objects |
CChObjectExplorer | A helper class to provide some basic mechanism of C++ reflection (introspection) |
CChOMP | Dummy no-op functions in case that no parallel multithreading via OpenMP is available |
CCHOMPmutex | Dummy no-op mutex in case that no parallel multithreading via OpenMP is available |
CCHOMPscopedLock | Exception-safe wrapper to a mutex: it automatically locks the mutex as soon as the wrapper is created, and releases the mutex when the wrapper is deleted (you simply put the wrapper in a code section delimited by {} parentheses, so it is deleted by the compiler when exiting the scope of the section or in case of premature exit because of an exception throw) |
CChOutputASCII | Output objects structure to a human-readable ASCII format |
CChParticle | Class for a single particle clone in the ChParticleCloud cluster |
CChParticleBase | Base class for a single particle to be used in ChIndexedParticles containers |
►CChParticleCloud | Class for clusters of 'clone' particles, that is many rigid objects with the same shape and mass |
CColorCallback | Class to be used as a callback interface for dynamic coloring of particles in a cloud |
CVisibilityCallback | Class to be used as a callback interface for dynamic visibility of particles in a cloud |
CChParticleContainer | Container of rigid particles (3 DOF) |
CChPhysicsItem | Base class for physics items that are part of a simulation |
CChProjectConstraints | Functor class for performing projection on the hyper-cone |
CChProjectNone | Functor class for performing a single cone projection |
CChProperty | Base class for properties to attach to vertices or particles as arrays of data |
CChPropertyColor | Data is an array of colors |
CChPropertyQuaternion | Data is an array of quaternions (for rotations) |
CChPropertyScalar | Data is an array of floats |
CChPropertyT | Templated property: a generic array of items of type T |
CChPropertyVector | Data is an array of vectors |
►CChProximityContainer | Class representing the interface for containers of proximity pairs, that is pairs of collision models that have been obtained from the broadphase collision |
CAddProximityCallback | Class to be used as a callback interface for some user defined action to be taken each time a proximity info is added to the container |
CReportProximityCallback | Class to be used as a callback interface for some user defined action to be taken for each proximity pair (already added to the container) |
CChQuadrature | Gauss-Legendre quadrature in 1D, 2D, or 3D |
CChQuadratureTables | Polynomial roots and weights for the Gauss-Legendre quadrature |
CChQuadratureTablesTetrahedron | Polynomial roots and weights for quadrature over a tetrahedron |
CChQuadratureTablesTriangle | Polynomial roots and weights for quadrature over a triangle |
CChQuaternion | Class defining quaternion objects, that is four-dimensional numbers |
►CChRayTest | Class for performing ray intersection tests |
CRayHitInfo | Information on ray intersection test result |
CChRealtimeStepTimer | Class for a timer which attempts to enforce soft real-time |
CChRoundedBox | A rounded box (sphere-swept box) geometric object for collisions and visualization |
CChRoundedCylinder | A rounded cylinder (sphere-swept cylinder) geometric object for collision and visualization |
CChSchurProduct | Functor class for calculating the Schur product of the matrix of unilateral constraints |
CChSchurProductBilateral | Functor class for performing the Schur product of the matrix of bilateral constraints |
CChShaft | Class for one-degree-of-freedom mechanical parts with associated inertia (mass or moment of rotational inertia) |
CChShaftBodyRotation | Constraint between a 3D ChBody object and a ChShaft object that represents a 1D rotational DOF |
CChShaftBodyTranslation | Constraint between a 3D ChBody object and a ChShaft object that represents a 1D translational DOF |
CChShaftsAppliedTorque | Class for defining a user-defined torque between two one-degree-of-freedom parts |
CChShaftsClutch | Class for defining a clutch or a brake (1D model) between two one-degree-of-freedom parts |
CChShaftsCouple | Base class for defining constraints between a couple of two one-degree-of-freedom parts |
CChShaftsElasticGear | Elastic gear coupling between two shafts |
CChShaftsFreewheel | Class for defining a 'freewheel' (a 1D model of a ratchet wheel) between two one-degree-of-freedom parts |
CChShaftsGear | Class for defining a 'transmission ratio' (a 1D gear) between two one-degree-of-freedom parts |
CChShaftsGearbox | Class for defining a gearbox |
CChShaftsGearboxAngled | Class for defining a gearbox with 1D input and 1D output, but with different directions in 3D space |
CChShaftsLoad | Base class for defining loads between a couple of two one-degree-of-freedom parts |
CChShaftsMotor | Base class for all motors between two 1D elements of ChShaft class |
CChShaftsMotorLoad | Motor to apply a load between two shafts |
CChShaftsMotorPosition | Motor to enforce the relative position r(t) between two shafts, using a rheonomic constraint |
CChShaftsMotorSpeed | Motor to enforce the relative speed w(t) between two shafts, using a rheonomic constraint |
CChShaftsPlanetary | Class for defining a planetary gear between three one-degree-of-freedom parts |
CChShaftsThermalEngine | Class for defining a thermal engine between two one-degree-of-freedom parts/ The first shaft is the 'crankshaft' to whom the torque is applied, the second is the motor block, that receives the negative torque |
CChShaftsTorque | Base class for all classes defining a torque between two one-degree-of-freedom parts |
CChShaftsTorqueConverter | Class for defining a torque converter between two one-degree-of-freedom parts |
CChShaftsTorsionSpring | Class for defining a torsional spring-damper between two 1D parts |
CChShaftsTorsionSpringDamper | Class for defining a torsional spring-damper between two 1D parts |
CChSharedMassBody | Reference to a single mass property shared by multiple ChVariablesBodySharedMass objects |
CChSolver | Base class for all Chrono solvers (for linear problems or complementarity problems) |
CChSolverADMM | An iterative solver based on modified version of ADMM Alternating Direction Method of Multipliers |
CChSolverAPGD | An iterative solver based on Nesterov's Projected Gradient Descent |
CChSolverBB | An iterative solver based on modified Krylov iteration of spectral projected gradients with Barzilai-Borwein |
CChSolverBiCGSTAB | BiCGSTAB iterative solver |
CChSolverComplexPardisoMKL | Sparse complex Pardiso direct solver |
CChSolverGMRES | GMRES iterative solver |
CChSolverLS | Base class for solvers aimed at solving linear systems |
CChSolverMatlab | Class for using a Matlab linear solver from Chrono programs |
CChSolverMINRES | MINRES iterative solver |
CChSolverMulticore | Base class for all Chrono::Multicore solvers |
CChSolverMulticoreAPGD | Accelerated Projected Gradient Descent (APGD) solver |
CChSolverMulticoreAPGDREF | Accelerated Projected Gradient Descent (APGD) solver. Reference implementation |
CChSolverMulticoreBB | Barzilai-Borwein solver |
CChSolverMulticoreCG | Conjugate gradient solver |
CChSolverMulticoreGS | Gauss Seidel solver |
CChSolverMulticoreJacobi | Jacobi solver |
CChSolverMulticoreMinRes | MINRES solver |
CChSolverMulticoreSPGQP | Spectral Projected Gradient solver |
CChSolverMumps | Interface to the MUMPS parallel sparse direct solver |
CChSolverPardisoMKL | Interface to the Intel MKL Pardiso parallel sparse direct solver |
CChSolverPJacobi | An iterative solver for VI based on projective fixed point method (projected Jacobi) |
CChSolverPMINRES | An iterative solver based on modified Krylov iteration of MINRES type with gradient projections (similar to nonlinear CG with Polyak-Ribiere) |
CChSolverPSOR | An iterative solver based on projective fixed point method, with overrelaxation and immediate variable update as in SOR methods |
CChSolverPSSOR | An iterative solver based on symmetric projective fixed point method, with overrelaxation and immediate variable update as in SSOR methods |
CChSolverSparseComplexLU | Sparse complex LU direct solver |
CChSolverSparseComplexQR | Sparse complex QR direct solver |
CChSolverSparseLU | Sparse LU direct solver |
CChSolverSparseQR | Sparse QR direct solver |
CChSolverVI | Base class for solvers aimed at solving complementarity problems arising from QP optimization problems |
CChSparsityPatternLearner | Utility class for extracting sparsity patter from a sparse matrix |
CChSphere | A spherical geometric object for collisions and visualization |
CChStarMatrix33 | Special MBD 3x3 "star" matrix, , representing vector cross products |
CChStarMatrix44 | Special MBD 4x4 "star" matrix, representing quaternion cross product |
CChState | Class for state of time-integrable objects |
CChStateDelta | Class for incremental form of state of time-integrable objects |
CChStaticAnalysis | Base class for static analysis |
CChStaticLinearAnalysis | Linear static analysis |
CChStaticNonLinearAnalysis | Nonlinear static analysis |
►CChStaticNonLinearIncremental | Nonlinear static analysis where the user can define external load(s) that will be incremented gradually during the solution process |
CLoadIncrementCallback | Class to be used as a callback interface for updating the system at each step of load increment |
►CChStaticNonLinearRheonomicAnalysis | Nonlinear static analysis for a mechanism that is rotating/moving in steady state |
CIterationCallback | Callback interface for updating the system at each iteration |
CChStrainTensor | Class for strain tensors, in compact Voight notation that is with 6 components in a column |
CChStressTensor | Class for stress tensors, in compact Voight notation that is with 6 components in a column |
CChSurface | Base class for all geometric objects representing bi-parametric surfaces in 3D space |
CChSurfaceNurbs | Geometric object representing a NURBS surface |
►CChSystem | Chrono Simulation System |
CCustomCollisionCallback | Class to be used as a callback interface for user defined actions performed at each collision detection step |
CChSystemDescriptor | Base class for collecting objects inherited from ChConstraint, ChVariables and optionally ChKRMBlock |
CChSystemDescriptorMulticore | System descriptor for Chrono::Multicore |
CChSystemMulticore | Base class for Chrono::Multicore systems |
CChSystemMulticoreNSC | Multicore system using non-smooth contact (complementarity-based) method |
CChSystemMulticoreSMC | Multicore system using smooth contact (penalty-based) method |
CChSystemNSC | Class for a physical system in which contact is modeled using a non-smooth (complementarity-based) method |
►CChSystemSMC | Class for a physical system in which contact is modeled using a smooth (penalty-based) method |
CChContactForceTorqueSMC | Base class for contact force calculation |
CChTexture | Class for defining a texture |
CChTimer | Chrono wrappers for the high-resolution timer |
CChTimerMulticore | Utility class for managing a collection of timer objects |
CChTimestepper | Base class for timesteppers, i.e., time integrators that can advance a system state |
CChTimestepperEulerExpl | Euler explicit timestepper |
CChTimestepperEulerExplIIorder | Euler explicit timestepper customized for II order |
CChTimestepperEulerImplicit | Performs a step of Euler implicit for II order systems |
CChTimestepperEulerImplicitLinearized | Performs a step of Euler implicit for II order systems using the Anitescu/Stewart/Trinkle single-iteration method, that is a bit like an implicit Euler where one performs only the first Newton corrector iteration |
CChTimestepperEulerImplicitProjected | Performs a step of Euler implicit for II order systems using a semi implicit Euler without constraint stabilization, followed by a projection |
CChTimestepperEulerSemiImplicit | Euler semi-implicit timestepper |
CChTimestepperHeun | Performs a step of a Heun explicit integrator. It is like a 2nd Runge Kutta |
CChTimestepperHHT | Implementation of the HHT implicit integrator for II order systems |
CChTimestepperIIorder | Base class for 2nd order timesteppers, i.e., a time integrator for a ChIntegrableIIorder |
CChTimestepperIorder | Base class for 1st order timesteppers, that is a time integrator for a ChIntegrable |
CChTimestepperLeapfrog | Performs a step of a Leapfrog explicit integrator |
CChTimestepperNewmark | Performs a step of Newmark constrained implicit for II order DAE systems |
CChTimestepperRungeKuttaExpl | Performs a step of a 4th order explicit Runge-Kutta integration scheme |
CChTimestepperTrapezoidal | Performs a step of trapezoidal implicit for II order systems |
CChTimestepperTrapezoidalLinearized | Performs a step of trapezoidal implicit linearized for II order systems |
CChTimestepperTrapezoidalLinearized2 | Performs a step of trapezoidal implicit linearized for II order systems |
CChTriangle | A triangle geometric shape for collisions and visualization |
CChTriangleMesh | Base class for triangle meshes |
►CChTriangleMeshConnected | A triangle mesh with connectivity info: vertices can be shared between faces |
CChRefineEdgeCriterion | Class to be used optionally in RefineMeshEdges() |
CChTriangleMeshSoup | A basic triangle mesh: just a list of triangles (no edge connectivity info) |
CChUniformDistribution | Class for a distribution with uniform probability between a lower 'min' value and upper 'max' value |
CChValue | Class to handle C++ values of generic type using type erasure and functors |
CChVariables | Base class for representing objects that introduce 'variables' and their associated mass submatrices |
CChVariablesBody | Specialized class for representing a 6-DOF 3D rigid body, with mass matrix and associated variables |
CChVariablesBodyOwnMass | Specialized class for representing a 6-DOF 3D rigid body, with mass matrix and associated variables |
CChVariablesBodySharedMass | Specialized class for representing a 6-DOF 3D rigid body, with mass matrix and associated variables |
CChVariablesGeneric | Specialized class for representing a N-DOF item for a system, that is an item with mass matrix and associate variables |
CChVariablesGenericDiagonalMass | Specialized class for representing a N-DOF item for a system, that is an item with a diagonal mass matrix and associated variables |
CChVariablesNode | Specialized class for representing a 3-DOF item for a system, that is a 3D point node, with mass matrix and associate variables (a 3 element vector, ex.speed) |
CChVariablesShaft | Specialized class for representing a 1-DOF item for a system, that is a shaft, with inertia and associated variable (rotational speed) |
CChVariableTupleCarrier_1vars | This is a set of 'helper' classes that make easier to manage the templated structure of the tuple constraints |
CChVector2 | Definition of a general purpose 2d vector |
CChVector3 | Definition of general purpose 3d vector variables, such as points in 3D |
CChVisualMaterial | Definition of a visual material |
CChVisualModel | Base class for a visual model which encapsulates a set of visual shapes |
CChVisualModelInstance | A visual model instance encodes a potentially shared visual model and its owning physics item |
CChVisualShape | Base class for a visualization asset for rendering (run-time or post processing) |
CChVisualShapeBarrel | Class for referencing a barrel shape (a lathed arc) that can be visualized in some way |
CChVisualShapeBox | Class for a box shape that can be visualized in some way |
CChVisualShapeCapsule | Class for referencing a capsule shape that can be visualized in some way |
CChVisualShapeCone | Class for referencing a cone shape that can be visualized in some way |
CChVisualShapeCylinder | Class for referencing a cylinder shape that can be visualized in some way |
CChVisualShapeEllipsoid | Class for referencing an ellipsoid shape that can be visualized in some way |
CChVisualShapeFEA | FEA mesh visualization |
CChVisualShapeLine | Class for referencing a ChLine that can be visualized in some way |
CChVisualShapeModelFile | Class for referencing a Wavefront OBJ file containing a shape that can be visualized in some way |
CChVisualShapePath | Class for referencing a ChLinePath that can be visualized in some way |
CChVisualShapePointPoint | Base class for visualization of some deformable line shape between two moving points related to the parent ChPhysicsItem |
CChVisualShapeRotSpring | Shape representing a rotational spring |
CChVisualShapeRoundedBox | Class for referencing a rounded box shape that can be visualized in some way |
CChVisualShapeRoundedCylinder | Class for referencing a rounded cylinder shape that can be visualized in some way |
CChVisualShapeSegment | Shape for visualizing a line segment between two moving points related to the parent ChPhysicsItem |
CChVisualShapeSphere | A spherical geometric object for collisions and visualization |
CChVisualShapeSpring | Shape for visualizing a coil spring between two moving points related to the parent ChPhysicsItem |
CChVisualShapeSurface | Class for referencing a ChSurface u,v, parametric surface that can be visualized in some way |
CChVisualShapeTriangleMesh | Class for referencing a triangle mesh shape that can be visualized in some way |
CChVisualSystem | Base class for a Chrono run-time visualization system |
CChVoightTensor | Base class for stress and strain tensors, in compact Voight notation |
CChVolume | Base class for all geometric objects representing tri-parametric surfaces in 3D space |
CChWeibullDistribution | Class that generates a Weibull distribution |
CChWrench | Definition of a wrench (force + torque) |
CChZhangDistribution | Class that generates the Zhang distribution, a modified exponential distribution |
Ccollision_measures | Collision_measures |
Ccollision_settings | Chrono::Multicore collision_settings |
CConvexBase | Base class for convex contact shapes |
CConvexShape | Convex contact shape |
CConvexShapeCustom | Custom contact shape |
CConvexShapeSphere | Sphere contact shape |
CConvexShapeTetrahedron | Tetrahedron contact shape |
CConvexShapeTriangle | Triangle contact shape |
CHeightColorCallback | Predefined particle cloud dynamic coloring based on particle height |
Chost_container | Structure of arrays containing simulation data |
Cmeasures_container | Aggregate of collision and solver measures |
CMPM_Settings | Settings for the Material Point Method |
Cquaternion | Chrono multicore quaternion class |
Creal2 | Chrono::Multicore pair (2-dimensional vector) |
Creal3 | Chrono::Multicore triplet (3-dimensional vector) |
Creal4 | Chrono multicore qudruple (4-dimensional array) |
Csettings_container | Aggregate of all settings for Chrono::Multicore |
Cshape_container | Structure of arrays containing rigid collision shape information |
Csolver_measures | Solver measures |
Csolver_settings | Chrono::Multicore solver_settings |
Cstate_container | Structure of arrays containing state data |
CTimerData | Wrapper class for a timer object |
►Nchrono_types | Namespace for custom make_shared implementation |
Cclass_has_custom_new_operator | Check if a class has a custom new operator |
►Nirr | Main Irrlicht namespace (Chrono extensions) |
►Ncore | Irrlicht base classes (Chrono extensions) |
Cmatrix4CH | Utility class to convert a Chrono frame into an Irrlicht transform |
Cvector3dfCH | Utility class to convert a Chrono vector into an Irrlicht vector3df |
►Nscene | Irrlicht base classes (Chrono extensions) |
CChCascadeIrrMeshTools | Tools to convert OpenCASCADE shapes into 'Irrlicht' triangle meshes |
CAreaLight | The different types of area lights that can exist in our current models |
CCameraMissParameters | The parameters associated with camera miss data. A.K.A background data |
CCameraParameters | The parameters needed to define a camera |
CContextParameters | Parameters associated with the entire optix scene |
CLensParams | Inverse lens param for modeling polynomial forward model |
CLidarParameters | Parameters used to define a lidar |
CMaterialParameters | All parameters for specifying a material in optix |
CMaterialRecordParameters | Parameters associated with a single object in the scene. Padding added during record creation |
CMeshParameters | All the data to specific a triangle mesh |
CMissParameters | The parameters for a camera miss record |
CPerRayData_camera | Data associated with a single camera ray |
CPerRayData_lidar | Data associated with a single lidar ray |
CPerRayData_radar | Data associated with a single radar ray |
CPerRayData_semantic | Data associated with a single segmentation camera ray |
CPerRayData_shadow | Data associated with a single shadow ray |
CPointLight | Packed parameters of a point light |
CRadarParameters | Parameters used to define a radar |
CRaygenParameters | Parameters for specifying raygen programs |
CSemanticCameraParameters | Parameters need to define a camera that generates semantic segmentation data |
CSynDDSMessage | This class represents the structure SynDDSMessage defined by the user in the IDL file |
CSynDDSMessagePubSubType | This class represents the TopicDataType of the type SynDDSMessage defined by the user in the IDL file |