XC Open source finite element analysis program
Classes | Typedefs | Enumerations | Functions | Variables
XC Namespace Reference

================================================================================ More...

Classes

class  Actor
 
class  ActorMethod
 
class  ActorPetscSOE
 ??. More...
 
class  ActorSubdomain
 
class  AdkZhangMeritFunctionCheck
 
class  AggregatorAdditions
 pointers to UniaxialMaterial with the degree of freedom associated to each of them (used in SectionAggregator). More...
 
class  AlgorithmIncrements
 AlgorithmIncrements will display the X and B in the SOE associated with the algorithm on a record. More...
 
class  AlphaBaseMachineBroker
 DEC Alpha machine broker? More...
 
class  AlphaMachineBroker
 
class  AlphaOS
 AlphaOS is an algorithmic class for performing a transient analysis using the Alpha-Operator-Splitting integration scheme. The parameter alpha corresponds to 1+alpha_{HHT}. More...
 
class  AlphaOSBase
 AlphaOSBase is an algorithmic class for performing a transient analysis using the Alpha-Operator-Splitting integration scheme. The parameter alpha corresponds to 1+alpha_{HHT}. More...
 
class  AlphaOSGeneralized
 AlphaOSGeneralized is an algorithmic class for performing a transient analysis using the generalized Alpha-Operator-Splitting integration scheme. The parameters alpha correspond to 1+alpha_{HHT}. More...
 
class  Analysis
 Clase Base para los objetos que realizan the analysis. More...
 
class  AnalysisModel
 Los objetos de esta clase, dan acceso a los objetos FE_Element y DOF_Group creados por el Constraint Handler. More...
 
class  ArcLength
 ArcLength is an algorithmic class for perfroming a static analysis using the arc length scheme. More...
 
class  ArcLength1
 ArcLength1 is an algorithmic class for perfroming a static analysis using the arc length scheme. More...
 
class  ArcLengthBase
 Base class for the arc-length integrators family. More...
 
class  ArcoCircunf
 Circumference arc. More...
 
class  ArmijoStepSizeRule
 
class  ArpackSOE
 Arpack++ based system of equations. More...
 
class  ArrayCommMetaData
 Data about the position, size, ... of the array to transmit. More...
 
class  ArrayGraph
 Array de grafos. More...
 
class  ArrayOfTaggedObjects
 ArrayOfTaggedObjects is a storage class. The class is responsible for holding and providing access to objects of type TaggedObject. The data structure used to hold the objects is a simple array of pointers. As a one dimensional array is used certain ideas are tried to improve performance: (1) if the array needs to be larger to hold more components, the array size is doubled and (2) when adding/retrieving components, the array location given by the components tag is first checked. More...
 
class  ArrayOfTaggedObjectsIter
 
class  ArrayVertexIter
 ArrayVertexIter is an iter for returning the vertices of an object of class ArrayGraph. ArrayVertexIter must be written for each subclass of ArrayGraph: wherin the vertices are stored differently to that in ArrayGraph. More...
 
class  Attalla2D
 Atalla 2D yield surface. More...
 
class  AuxMatrix
 
class  BandArpackppSOE
 Arpack++ based band matrix eigenvalue SOE solver. More...
 
class  BandArpackppSolver
 Arpack++ based band matrix eigenproblem solver. More...
 
class  BandArpackSOE
 BandArpackSOE is a subclass of ArpackSOE. It uses the LAPACK storage scheme to store the components of the K, M matrix, which is a full matrix. It uses the Arpack to do eigenvalue analysis. More...
 
class  BandArpackSolver
 Arpack solver for banded matrices. The ARnoldi PACKage, is a numerical software library written in FORTRAN 77 for solving large scale eigenvalue problems. More...
 
class  BandGenLinLapackSolver
 Lapack based band general matrix SOE solver. More...
 
class  BandGenLinSOE
 Uses the LAPACK storage scheme to store the components of the A matrix, which is a banded unsymmetric matrix. More...
 
class  BandGenLinSolver
 Base class for band general linear SOE solvers. More...
 
class  BandSPDLinLapackSolver
 Lapack based band matrix linear SOE solver. More...
 
class  BandSPDLinSOE
 Base class for band matrix system of equations. More...
 
class  BandSPDLinSolver
 Solver for band matrix linear systems of equations. More...
 
class  BandSPDLinThreadSolver
 Solves the BandSPDLinSOE in parallel using solaris threads. More...
 
class  BarSlipMaterial
 The file generates the 4 point envelope for both positive and negative loading and is basically a wrapper for the Pinching4 material at it's outset. More...
 
class  BaseControl
 Base class for load and displacement control static integrators . More...
 
class  BaseElasticSection
 Base class for cross sections with linear elastic material. More...
 
class  BaseElasticSection2d
 Base class for cross sections with linear elastic material on a bi-dimensional problem (3 DOFs on each section). More...
 
class  BaseElasticSection3d
 Base class for cross sections with linear elastic material on a three-dimensional problem (6 DOFs on each section). More...
 
class  BaseNumberer
 Base class for DOF numberers. More...
 
class  BasicGFunEvaluator
 
class  BbarBrick
 Hexaedro. More...
 
class  beam2d
 2D beam element. More...
 
class  beam2d02
 2D beam 02 element. More...
 
class  beam2d03
 2D 03 beam element. More...
 
class  beam2d04
 2D beam element 04. More...
 
class  Beam2dPointLoad
 Punctual load over 2D beam elements. More...
 
class  Beam2dUniformLoad
 Uniform load over 2D beam elements. More...
 
class  beam3d01
 01 3D beam element. More...
 
class  beam3d02
 02 3D bar element. More...
 
class  beam3dBase
 Base class for 3D beam elements. More...
 
class  Beam3dPointLoad
 Punctual load over 3D beams. More...
 
class  Beam3dUniformLoad
 Uniform load over 3D beams. More...
 
class  BeamColumnJoint2d
 2D beam column joint. More...
 
class  BeamColumnJoint3d
 3D beam-column joint element. More...
 
class  BeamColumnJointPhysicalProperties
 Physical properties for shells. More...
 
class  BeamColumnWithSectionFD
 Beam-column element with SeccionBarraPrismatica material. More...
 
class  BeamColumnWithSectionFDTrf2d
 2D beam element with SectionForceDeformation type material. More...
 
class  BeamColumnWithSectionFDTrf3d
 3D beam colun element with SeccionBarraPrismatica material type. More...
 
class  BeamFiberMaterial
 BeamFiberMaterial class is a wrapper class that performs static condensation on a three-dimensional material model to give the 11, 12, and 13 stress components which can then be integrated over an area to model a shear flexible 3D beam. More...
 
class  BeamIntegration
 Base class for integration on beam elements. More...
 
class  BeamIntegratorLoader
 Beam integrators handler. More...
 
class  BeamLoad
 Load over beam elements. More...
 
class  BeamMecLoad
 Mechanical loads (forces) over beam elements. More...
 
class  BeamPointLoad
 Punctual load over beam elements. More...
 
class  BeamStrainLoad
 Load due to restricted material expansion or contraction on beam elements. More...
 
class  BeamUniformLoad
 Uniform load over beam elements. More...
 
class  BeamWithHinges2d
 2D beam with hinges in both ends. More...
 
class  BeamWithHinges3d
 3D beam with hinges in both ends. More...
 
class  BerkeleyDbDatastore
 
class  BetaRV
 
class  BFBRoydenBase
 ?? More...
 
class  BFGS
 ?? More...
 
class  BidimLoad
 Load over bidimensional elements. More...
 
class  BidimMecLoad
 Mechanical load (forces) over bidimensional elements. More...
 
class  BidimStrainLoad
 Load due to restricted material expansion or contraction on bidimensional elements. More...
 
class  Bidirectional
 ?? More...
 
class  Bilinear
 ??. More...
 
class  BilinearCyclic
 ??. More...
 
class  BisectionLineSearch
 Bisection line search solution algorithm. More...
 
class  BJmatrix
 
class  BJtensor
 
class  BJvector
 
class  BkStressLimSurface2D
 ??. More...
 
class  Block
 Six-faced body. More...
 
class  Body
 Six-faced solid. More...
 
class  BodyForces
 Body forces over an element. More...
 
class  BodyForces2D
 Body forces over an element. More...
 
class  BodyForces3D
 Body forces over an element. More...
 
class  BoucWenMaterial
 ??. More...
 
class  BoundingSurface2D
 Bounding 2D yield surface. More...
 
class  Brick
 Hexaedro de ocho nodos. More...
 
class  BrickBase
 Base class for hexahedra. More...
 
class  BrickSelfWeight
 Hexahedron self weight. More...
 
class  BrickUP
 Hexaedro de ocho nodos. More...
 
class  BrokedPtrCommMetaData
 Data to transmit for a pointer «broked». More...
 
class  Broyden
 Algoritmo de Broyden. More...
 
class  CableMaterial
 CableMaterial provides the abstraction of an elastic uniaxial material, the input parameters are the Prestress, E, Effective Self Weight (gravity component of Weight per volume transverse to the cable), and Length of the cable. More...
 
class  Cad
 Model geometry manager. Management of geometry entities: points, lines, surfaces, bodies, etc. More...
 
class  CAMPotentialSurface
 ??. More...
 
class  CAMYieldSurface
 ??. More...
 
class  Cell
 Base class for cells (cross-section discretization). More...
 
class  CentralDifference
 CentralDifference is an algorithmic class for performing a transient analysis using the central difference integration scheme. More...
 
class  CentralDifferenceAlternative
 CentralDifferenceAlternative is an algorithmic class for performing a transient analysis using the alternative form of the Central Differenceintegration scheme, which is an explicit direct integration scheme as outlined in the book 'Concepts and Applications of Finite Element Analysis' by Cook, Malkus & Plesha. More...
 
class  CentralDifferenceBase
 Approximates velocity and acceleration by centered finite differences of displacement. More...
 
class  CentralDifferenceNoDamping
 CentralDifferenceNoDamping is an algorithmic class for performing a transient analysis using the Central Difference Scheme as implemented in Dyna. More...
 
class  CFactorSeries
 Base class for constant factor time series. More...
 
class  Channel
 Channel is an abstract base class which defines the channel interface. A channel is a point of communication in a program, a mailbox to/from which data enters/leaves a program. More...
 
class  ChannelAddress
 
class  ChannelQueue
 Data about the postion, size,... of the object to transmit. More...
 
class  ChiSquareRV
 
class  CircReinfLayer
 Capa de armaduras en forma de arco de circulo. More...
 
class  ClosedTriangleMesh
 @ingroup MATSCCDiagInt More...
 
class  Clough
 ??. More...
 
class  CloughDamage
 ??. More...
 
class  CmbEdge
 Compound line. More...
 
class  Collocation
 Collocation is an algorithmic class for performing a transient analysis using the Collocation integration scheme. More...
 
class  CollocationHybridSimulation
 CollocationHybridSimulation is an algorithmic class for performing a transient analysis using the CollocationHybridSimulation integration scheme. More...
 
class  CombinedIsoKin2D01
 ??. More...
 
class  CombinedIsoKin2D02
 Kinematic model is based on back-stress Isotropic model on plastic-deformations This one is also deformable. More...
 
class  CommMetaData
 Data about the index, size,,... of the object to transmit. More...
 
class  CommParameters
 Communication parameters between processes. More...
 
class  CompositeSimpsonBeamIntegration
 Composite Simpson integration scheme. More...
 
class  ComputePivots
 Given a bending plane, computes the "pivots" position on the section. More...
 
struct  Conc02HistoryVars
 Concrete02 history variables. More...
 
class  Concrete01
 Uniaxial Kent-Scott-Park concrete model with linear unloading/reloading according to the work of Karsan-Jirsa and no strength in tension. The model contains a compressive strength of fpc, a strain at the compressive strength of epsc0, a crushing strength of fpcu, and a strain at the crushing strength of epscu. Compressive concrete parameters should be input as negative numeric values for this model to behave properly. Specification of minimum and maximum failure strains through the -min and -max switches is optional. The argument matTag is used to uniquely identify the material object among material objects in the BasicBuilder object. More...
 
class  Concrete02
 Uniaxial model for concrete with tensile strength and tension softenint. Reference: Mohd Hisham Mohd Yassin, "Nonlinear Analysis of Prestressed Concrete Structures under Monotonic and Cycling Loads", PhD dissertation, University of California, Berkeley, 1994. More...
 
class  Concrete04
 Uniaxial Popovics concrete material object with degraded linear unloading/reloading stiffness according to the work of Karsan-Jirsa and tensile strength with exponential decay. More...
 
class  ConcreteBase
 Base class for concrete materials. More...
 
class  ConjugateGradientSolver
 Base class for conjugate gradient linear SOE solvers. More...
 
class  ConnectedMaterial
 Connected uniaxial materials (parallel or serial). More...
 
class  ConsoleErrorHandler
 
class  ConstantModulatingFunction
 
class  ConstantPressureVolumeQuad
 ??. More...
 
class  ConstantSeries
 Constant function over time. More...
 
class  Constraint
 Base class for model constraints. More...
 
class  ConstraintHandler
 ConstraintHandlers enforce the single and multi freedom constraints that exist in the domain by creating the appropriate FE_Element and DOF_Group objects. More...
 
class  ConstraintLoader
 Constraint cration tools. More...
 
class  ConstrContainer
 Constraint (essential and natural boundary conditions) container. More...
 
class  ContinuaReprComponent
 Base class for components used to represent the material (continuum). More...
 
class  ConvergenceTest
 convergence test. More...
 
class  ConvergenceTestNorm
 Convergence test that uses vector norm value (solution vector,...). More...
 
class  ConvergenceTestTol
 Convergence test with tolerance threshold. More...
 
class  CorotCrdTransf2d
 Coordinate transformation corrotacional en 3d. More...
 
class  CorotCrdTransf3d
 Coordinate transformation corrotacional en 3d. More...
 
class  CorotShellMITC4
 MIT C4 shell element. More...
 
class  CorotTruss
 Truss element with corotational formulation. A small strain, large displacement corotational space truss element, as described by Crisfield in "Nonlinear Finite Element Analysis of Solids and Structures", Vol. 1, 1991, J.T. Wiley. More...
 
class  CorotTrussBase
 Base class for corotational truss elements. More...
 
class  CorotTrussSection
 Truss element with corotatinal formulation and material of type SectionForceDeformation. Small strain, large displacement corotational space truss element, as described by Crisfield in "Nonlinear Finite Element Analysis of Solids and Structures", Vol. 1, 1991, J.T. Wiley. More...
 
class  CorrelationCoefficient
 
class  Cosseratstraintensor
 
class  Cosseratstresstensor
 
class  CoulombFriction
 
class  CrdTransf
 CrdTransf provides the abstraction of a frame coordinate transformation. It is an abstract base class and thus no objects of it's type can be instatiated. It has pure virtual functions which must be implemented in it's derived classes. More...
 
class  CrdTransf2d
 Base class for 2D coordinate transformation. More...
 
class  CrdTransf3d
 Base class for 3D coordinate transformation. More...
 
class  CriteriaReductionMeritFunctionCheck
 
class  CrossSectionProperties2d
 Mechanical properties of a cross section (area, moments of inertia,...) for a bi-dimensional problem (three DOB for each section). More...
 
class  CrossSectionProperties3d
 Mechanical properties of a section (area, moments of inertia,...) in a three-dimensional problem (six degrees of freedom on each section). More...
 
class  CStdLibRandGenerator
 
class  CTestEnergyIncr
 Specifies a tolerance for the product of unbalanced load vector and 0.5 times the displacement increment vector (energy increment) to be used as convergence criterion on each iteration. More...
 
class  CTestFixedNumIter
 This object performs a fixed number of iterations without testing for convergence. This test is useful for hybrid simulation where the residual error is corrected for. More...
 
class  CTestNormDispIncr
 Specifies a tolerace for the displacement increment norm to be used on each iteration. More...
 
class  CTestNormUnbalance
 Specifies a tolerance for the norm of the unbalanced load vector on each iteration. More...
 
class  CTestRelativeEnergyIncr
 Tests for convergence using the ratio of the current norm to the initial norm (the norm when start is invoked) of the which is 0.5 times the absolute value of the product of the rhs and the solution vector of the LinearSOE. More...
 
class  CTestRelativeNormDispIncr
 tests for convergence using the ratio of the current norm to the initial norm (the norm when start is invoked) of the solution vector of the LinearSOE object passed in the constructor and a tolerance, set in the constructor. More...
 
class  CTestRelativeNormUnbalance
 convergence test tests for convergence using the ratio of the current norm to the initial norm (the norm when start is invoked) of the right hand side vector of the LinearSOE object passed in the constructor and a tolerance, set in the constructor. More...
 
class  CTestRelativeTotalNormDispIncr
 Convergence test thats uses the quotient of current and initial norms of the solution vector. More...
 
class  CurvaturesBySearchAlgorithm
 
class  CyclicModel
 ??. More...
 
class  DamageModel
 
class  DamageModelVector
 Vector de pointers to damage models. se emplea en Joint2D. More...
 
class  DamageRecorder
 Used to obtain a response from an element section/material during the analysis and apply the information to the damage model and record the damage index. More...
 
class  DamageResponse
 
class  DampingFactorsIntegrator
 ??. More...
 
class  DataOutputDatabaseHandler
 
class  DataOutputFileHandler
 
class  DataOutputHandler
 
class  DataOutputStreamHandler
 
class  DatastoreRecorder
 
class  DBDatastore
 
class  DbTagData
 Vector que almacena los dbTags de los miembros de la clase. More...
 
class  DecMachineBroker
 Broker for DEC machines. More...
 
class  DefaultTag
 Default tag. More...
 
class  DeformationPlane
 Deformation plane for a cross-section. More...
 
class  DiagonalDirectSolver
 Direct solver for diagonal matrix SOE. More...
 
class  DiagonalSOE
 Diagonal matrix system of equations. More...
 
class  DiagonalSolver
 Base class for diagonal matrix linear SOE solvers. More...
 
class  DirectIntegrationAnalysis
 Direct integration dynamic analysis. More...
 
class  DiscretBase
 Base class for cross-section discretization. More...
 
class  DiscretizedRandomProcessSeries
 ??. More...
 
class  DispBase
 ?? More...
 
class  DispBeamColumn2d
 displacement based 2D beam element with SeccionBarraPrismatica type material. More...
 
class  DispBeamColumn3d
 3D beam element with SeccionBarraPrismatica type material. More...
 
class  DisplacementControl
 DisplacementControl is an algorithmic class for perfroming a static analysis using the arc length scheme, that is within a load step the follwing constraint is enforced: i=1 delta U^T delta U + alpha^2 delta lambda^2 = delta s^2 i>1 dU^T delta U + alpha^2 dLambda delta lambda = 0 where dU is change in nodal displacements for step, dLambda is change in applied load and DisplacementControl is a control parameter. More...
 
class  DistHingeIntegration
 ??. More...
 
class  DistributedBandGenLinSOE
 Base class for band general matrix distributed systems of equations. More...
 
class  DistributedBandLinSOE
 Base class for band matrix distributed systems of equations. More...
 
class  DistributedBandSPDLinSOE
 Base class for band matrix distributed systems of equations. More...
 
class  DistributedBase
 Base class for distributed processing. More...
 
class  DistributedDiagonalSOE
 Diagonal matrix distributed systems of equations. More...
 
class  DistributedDiagonalSolver
 Base class for distributed (many processors) diagonal matrix linear SOE solvers. More...
 
class  DistributedDisplacementControl
 ??. More...
 
class  DistributedLinSOE
 Base class for distributed systems of equations. More...
 
class  DistributedObj
 Object distributed on many processes. More...
 
class  DistributedProfileSPDLinSOE
 Profile matrix distributed systems of equations. More...
 
class  DistributedSparseGenColLinSOE
 Sparse nonsymmetric matrix distributed system of equations. More...
 
class  DistributedSparseGenRowLinSOE
 Sparse nonsymmetric matrix distributed systems of equations. More...
 
class  DistributedSparseGenRowLinSolver
 Base class for distributed (many processors) sparse general matrix linear based SOE solver. More...
 
class  DistributedSuperLU
 SuperLU based solver for distributed sparse matrix linear systems of equations. It uses Gaussian elimination with partial pivoting (GEPP). The columns of A may be preordered before factorization; the preordering for sparsity is completely separate from the factorization and a number of ordering schemes are provided. More...
 
class  DividedLine
 Line segment between two points. More...
 
class  DOF_Graph
 Degrees of freedom graph. More...
 
class  DOF_Group
 A DOF_Group object is instantiated by the ConstraintHandler for every unconstrained node in the domain. The constrained nodes require specialised types of DOF_Group; which deal with the constraints. DOF_Group objects can handle 0 boundary constraints; if the eqn number of a DOF is less than START_EQN_NUM a value of 0.0 is set for disp, vel and accel when a setNode*(Vector &) is invoked. More...
 
class  DOF_GroupGraph
 Degrees of freedom group. More...
 
class  DOF_GrpConstIter
 Iterator over DEF groups. More...
 
class  DOF_GrpIter
 Iterator over DOF groups. More...
 
class  DOF_Numberer
 Base class for DOF numbererers. More...
 
class  Domain
 Domain (mesh and boundary conditions) of the finite element model. More...
 
class  DomainComponent
 Objeto que forma parte de un domain. More...
 
class  DomainDecompAlgo
 Solution algorithm for domain decomposition. More...
 
class  DomainDecompositionAnalysis
 Used when performing a domain decomposition analysis. It provides methods which can be invoked by a subdomain to perform the numerical computations required. More...
 
class  DomainPartitioner
 
class  DomainRecorderBase
 Recording of domain information. More...
 
class  DomainSolver
 used to solve a system of equations and to do static condensation operations on the linear system of equations. More...
 
class  DomainUser
 ?? More...
 
struct  doubleData
 
class  DPPotentialSurface
 ??. More...
 
class  DPYieldSurface
 ??. More...
 
class  DPYieldSurface01
 ??. More...
 
class  DqFibras
 Contenedor de fibras. More...
 
class  DqGroundMotions
 Contenedor de definiciones de sismo. More...
 
class  DqMatrices
 
class  DqMeshRegion
 Vector de celdas. More...
 
class  DqPtrs
 Pointer to (nodes, elements, points, lines,...) container. More...
 
class  DqPtrsConstraint
 Constraint pointers deque. More...
 
class  DqPtrsElem
 Pointer to element container. More...
 
class  DqPtrsNmb
 
class  DqPtrsNode
 Contenedor de pointers to nodes. More...
 
class  DqUniaxialMaterial
 Contenedor de pointers to UniaxialMaterial. More...
 
class  DqVectors
 
class  DrainBilinearMaterial
 ??. More...
 
class  DrainClough1Material
 ??. More...
 
class  DrainClough2Material
 ??. More...
 
class  DrainHardeningMaterial
 ??. More...
 
class  DrainMaterial
 ??. More...
 
class  DrainPinch1Material
 ?? More...
 
class  DriftRecorder
 Records relative displacement between nodes. The drift is taken as the ratio between the prescribed relative displacement and the specified distance between the nodes. More...
 
class  DruckerPrager
 Drucker-Prager material. More...
 
class  DruckerPrager3D
 Drucker-Prager 3D material. More...
 
class  DruckerPragerPlaneStrain
 Drucker-Prager plane strain material. More...
 
class  DummyNode
 DummyNodes are a type of node created and used by Subdomains for their exterior nodes. They reference a real node and most methods invoked on them are in turn invoked by the dummy node on the real node. The calls asking the real node to change its current state are ignored. The calls involving DOF_Group are handled by the dummy node. More...
 
class  EarthquakePattern
 Earthquake load pattern. More...
 
class  Edge
 Base class for one-dimensional geometry objects. More...
 
class  EigenAlgorithm
 Solution algorithm for eigenproblem. More...
 
class  EigenAnalysis
 Eigenproblem analysis. More...
 
class  EigenIntegrator
 Base class for eigenproblem integrators. More...
 
class  EigenSOE
 Base class for eigenproblem systems of equations. More...
 
class  EigenSolver
 Eigenvalue SOE solver. More...
 
class  EightNodeBrick
 Hexaedro de ocho nodos. More...
 
class  EightNodeBrick_u_p_U
 Hexaedro de ocho nodos. More...
 
class  Eje
 Base class for 1D entities in section definition. More...
 
class  Elastic2dGNL
 Elastic2dGNL is a subclass of UpdatedLagrangianBeam2D, that can be. More...
 
class  ElasticBaseMaterial
 Base class for uniaxial elastic materials. More...
 
class  ElasticBeam2d
 2D elastic beam element. More...
 
class  ElasticBeam3d
 3D elastic beam element. More...
 
class  ElasticCrossAnisotropic
 Base class for elastic anisotropic materials. More...
 
class  ElasticIsotropic2D
 Isotropic elastic material for plane problems. More...
 
class  ElasticIsotropic3D
 Elastic isotropic material for 3D elements. More...
 
class  ElasticIsotropicAxiSymm
 Base class for elastic isotropic axisymmetric materials. More...
 
class  ElasticIsotropicBeamFiber
 Elastic isotropic material for beam fibers. More...
 
class  ElasticIsotropicMaterial
 Base class for elastic isotropic materials. More...
 
class  ElasticIsotropicPlaneStrain2D
 Elastic isotropic material for plane deformation problems. More...
 
class  ElasticIsotropicPlaneStress2D
 Elastic isotropic material for plane stress problems. More...
 
class  ElasticIsotropicPlateFiber
 Elastic isotropic material for plate elements. More...
 
class  ElasticMaterial
 Linear elastic uniaxial material. More...
 
class  ElasticMembranePlateSection
 Elastic section for membrane/plate materials. More...
 
class  ElasticPlateBase
 Base class for elastic plate materials. More...
 
class  ElasticPlateProto
 ??. More...
 
class  ElasticPlateSection
 Bidimensional elastic section for plate modellings. More...
 
class  ElasticPPMaterial
 Elastic perfectly plastic material. More...
 
class  ElasticSection2d
 Cross section with linear elastic material for bi-dimensional problesm (3 degrees of freedom in each section). More...
 
class  ElasticSection3d
 Cross section with linear elastic material in three-dimensional problems (6 degrees of freedom in each section). More...
 
class  ElasticShearSection2d
 Base clas for cross sections with linear elastic material with shear stiffness on a bi-dimensional space (3 DOF on each section). More...
 
class  ElasticShearSection3d
 Base class for cross sections with linear elastic material and shear stiffness on a three-dimensional space (6 degrees of freedom in each section). More...
 
class  Element
 Base calass for the finite elements. More...
 
class  Element0D
 Element of dimension 0 (both nodes have the same position). More...
 
class  Element1D
 Base class for one-dimensional elements (beam,truss,...) More...
 
class  ElementalLoad
 Base class for loads over elements. More...
 
class  ElementalLoadIter
 Iterador sobre las elemental loads. More...
 
class  ElementBase
 Base class for finite element with pointer to nodes container. More...
 
class  ElementBodyLoad
 Base class for body loads over elements. More...
 
class  ElementEdge
 Element edge (TO DEPRECATE?? LP 7.02.2017). More...
 
class  ElementEdges
 Element edge container. More...
 
class  ElementIter
 Iterator over an element container. More...
 
class  ElementLoader
 Element creation manager. More...
 
class  ElementPropRecorder
 Objects to record element data at each commit. More...
 
class  ElementPtrs
 Pointers to the elements affected by the load. More...
 
class  ElementRecorder
 Recording of element response. More...
 
class  ElementRecorderBase
 Base class for the finite element response recorders. More...
 
class  ElementResponse
 
class  ElemFriccionBase
 
class  ElemPlano
 Base class for plane elements. More...
 
class  ElemPos
 Element position for KDTree building. More...
 
class  ElemWithMaterial
 Element with material. More...
 
class  ElTawil2D
 El Tawil 2D yield surface. More...
 
class  ElTawil2DUnSym
 Unsymmetric 2D El Tawil yield surface. More...
 
class  EncapsulatedMaterial
 ??. More...
 
class  EnhancedQuad
 Four-node quadrilateral element, which uses a bilinear isoparametric formulation with enhanced strain modes. More...
 
class  EntGeomSection
 Base class of section geometry representation classes. More...
 
class  ENTMaterial
 Elastic no traction material. ENTMaterial provides the abstraction of an elastic uniaxial material under compression i.e. stress = E*strain under tension however it exhbits the following stress = a*(tanh(strain*b)) tangent = a*(1-tanh(strain*b)*tanh(strain*b));. More...
 
class  EntMdlr
 Multiblock topology object (point, line, face, block,...). More...
 
class  EntMdlrBase
 Base class of the preprocessor objects. More...
 
class  EnvelopeData
 
class  EnvelopeElementRecorder
 
class  EnvelopeNodeRecorder
 A EnvelopeRecorder is used to record the envelop of specified DOF responses at a collection of nodes over an analysis. (between commitTag of 0 and last commitTag). More...
 
class  EPPBaseMaterial
 Base class for elastic perfectly plastic materials. More...
 
class  EPPGapMaterial
 Elastic perfectly plastic material with initial "gap". provides the abstraction of an elastic perfectly plastic (tension only) path dependent uniaxial material, with an initial gap offset (force-displacement units) For compression only behavior, enter negative gap and ep Damage can accumulate through specification of damage = 1 switch, otherwise damage = 0. More...
 
class  EPState
 3 More...
 
class  EQBasePattern
 Earthquake load pattern. More...
 
class  EqualDOF
 Impose the values of many degrees of freedom to be the same. More...
 
class  EquiSolnAlgo
 EquiSolnAlgo is an abstract base class, i.e. no objects of it's type can be created. Its subclasses deifine the sequence of operations to be performed in the analysis by static equilibrium of a finite element model. More...
 
class  EquiSolnConvAlgo
 EquiSolnConvAlgo is a class which performs a Newton-Raphson solution algorihm in solving the equations. No member functions are declared as virtual as it is not expected that this class will be subclassed. More...
 
class  ErrorHandler
 
class  EsfBeamColumn3d
 3D beam column internal forces. More...
 
class  EvolutionLaw_L_Eeq
 ??. More...
 
class  EvolutionLaw_L_Eij
 ??. More...
 
class  EvolutionLaw_NL_Eeq
 ??. More...
 
class  EvolutionLaw_NL_Eij
 ??. More...
 
class  EvolutionLaw_NL_EijMD
 ??. More...
 
class  EvolutionLaw_NL_Ep
 This is a nonlinear evolution law for the evoltion of a scalar variable po which depends on plastic volumetric strain i.e. dpo = (1+eo)po/(lamda-kappa)*de_p. More...
 
class  EvolutionLaw_S
 ??. More...
 
class  EvolutionLaw_T
 ??. More...
 
class  ExponentialRV
 
class  ExponReducing
 XXX?? More...
 
class  Face
 Surface. More...
 
class  FactoredSOEBase
 Base class for factored systems of equations. More...
 
class  FactorsConstraintHandler
 Base class for penalty and Lagrange constraints handlers. More...
 
class  FatigueMaterial
 FatigueMaterial wraps a UniaxialMaterial and imposes fatigue limits. More...
 
class  FDdecoupledElastic3D
 ??. More...
 
class  FDEPState
 ??. More...
 
class  fdEvolution_S
 ??. More...
 
class  fdEvolution_SLS
 ??. More...
 
class  fdEvolution_T
 ??. More...
 
class  fdEvolution_TL
 ??. More...
 
class  fdFlow
 ??. More...
 
class  fdFlowDP
 ??. More...
 
class  fdFlowVM
 ??. More...
 
class  fdYield
 ??. More...
 
class  fdYieldDP
 ??. More...
 
class  fdYieldVM
 ??. More...
 
class  FE_Datastore
 
class  FE_EleConstIter
 Const iterator over the finite elements of the model. More...
 
class  FE_EleIter
 Iterator over the finite element of the model. More...
 
class  FE_Element
 Finite element as seen by analysis. More...
 
class  FE_VertexIter
 Iterador over the vertices of the graph. More...
 
class  FeapMaterial
 Base class for 2D and 3D FEAP materials. More...
 
class  FeapMaterial01
 material FEAP 01. More...
 
class  FeapMaterial02
 material FEAP 02. More...
 
class  FeapMaterial03
 material FEAP 03. More...
 
class  FedeasBond1Material
 FedeasBond1Material wraps the FEDEAS 1d material subroutine Bond_1. More...
 
class  FedeasBond2Material
 FedeasBond2Material wraps the FEDEAS 1d material subroutine Bond_2. More...
 
class  FedeasBondMaterial
 FedeasBondMaterial wraps the FEDEAS 1d material subroutine Bond_1. More...
 
class  FedeasConcr1Material
 FedeasConcr1Material wraps the FEDEAS 1d material subroutine Concr_1. More...
 
class  FedeasConcr2Material
 FedeasConcr2Material wraps the FEDEAS 1d material subroutine Concr_2. More...
 
class  FedeasConcr3Material
 FedeasConcr3Material wraps the FEDEAS 1d material subroutine Concr_3. More...
 
class  FedeasConcrMaterial
 FedeasConcrMaterial wraps the FEDEAS 1d material subroutine Concr_1. More...
 
class  FedeasHardeningMaterial
 FedeasHardeningMaterial wraps the FEDEAS 1d material subroutine Hard_1. More...
 
class  FedeasHyster1Material
 FedeasConcr2Material wraps the FEDEAS 1d material subroutine Concr_2. More...
 
class  FedeasHyster2Material
 FedeasHyster2Material wraps the FEDEAS 1d material subroutine Hyster_2. More...
 
class  FedeasMaterial
 FedeasMaterial provides a FORTRAN interface for programming uniaxial material models, using the subroutine interface from the FEDEAS ML1D library, developed by F.C. Filippou. More...
 
class  FedeasSteel1Material
 FedeasSteel1Material wraps the FEDEAS 1d material subroutine Steel_1. More...
 
class  FedeasSteel2Material
 FedeasSteel2Material wraps the FEDEAS 1d material subroutine Steel_2. More...
 
class  fElement
 Wrapper used to call fortran element subroutines from FEAP. More...
 
class  fElmt02
 Interface with FEAP elements. More...
 
class  fElmt05
 Interface with FEAP elements. More...
 
class  FEM_ObjectBroker
 FEM_ObjectBroker is is an object broker class for the finite element method. All methods are virtual to allow for subclasses; which can be used by programmers when introducing new subclasses of the main objects. More...
 
class  FEM_ObjectBrokerAllClasses
 The same as FEM_ObjectBroker? More...
 
class  Fiber
 Section fiber. More...
 
class  FiberData
 Fiber data. More...
 
class  FiberResponse
 Recorder for fiber response. More...
 
class  FiberSection2d
 Fiber section model in a bi-dimensional space. Sections stiffness and internal forces are obtained by addition of the fibers contribution. More...
 
class  FiberSection3d
 Fiber section model in a three-dimensional space. Sections stiffness and internal forces are obtained by addition of the fibers contribution. More...
 
class  FiberSection3dBase
 Base class for fiber sections on three-dimensional problems. More...
 
class  FiberSectionBase
 Base class for fiber sections. More...
 
class  FiberSectionGJ
 Fiber section with torsional stiffness. More...
 
class  FiberSectionRepr
 Fiber section representation. More...
 
class  FiberSectionShear3d
 FiberSectionShear3d decorates an MP section (couple bending and axial) with an uncoupled shear relation. More...
 
class  FiberSets
 Fiber sets container. More...
 
class  FieldInfo
 Information about a field defined over a set. More...
 
class  FileDatastore
 
struct  fileDatastoreOutputFile
 
class  FilePlotter
 A FilePlotter will create a line graph using xy points found in a file. Probably to deprecate. More...
 
class  FileStream
 
class  Filter
 
class  FindCurvatures
 
class  FindDesignPointAlgorithm
 
class  FiniteDeformationElastic3D
 3D finite deformation elastic material. More...
 
class  FiniteDeformationEP3D
 Finite deformation elasto-plastic 3D material. More...
 
class  FiniteDifferenceGradGEvaluator
 
class  FirstPrincipalCurvature
 
class  FixedLocationBeamIntegration
 Integration points at fixed locations. More...
 
class  FixedStepSizeRule
 
class  FlatSliderSimple2d
 
class  FlatSliderSimple3d
 
class  FluidSolidPorousMaterial
 ??. More...
 
class  ForceBeamColumn2d
 Force based 2D beam column element with SeccionBarraPrismatica type nonlinear material. More...
 
class  ForceBeamColumn3d
 3D force based beam column element with nonlinear SeccionBarraPrismatica type material. More...
 
class  ForceReprComponent
 Base class for components that represent forces. More...
 
class  FORMAnalysis
 
class  FOSMAnalysis
 
class  FourNodeQuad
 Four node quad. More...
 
class  FourNodeQuadUP
 Four-node plane-strain element using bilinear isoparametric formulation. This element is implemented for simulating dynamic response of solid-fluid fully coupled material, based on Biot's theory of porous medium. Each element node has 3 degrees-of-freedom (DOF): DOF 1 and 2 for solid displacement (u) and DOF 3 for fluid pressure (p). More...
 
class  FragilityAnalysis
 
class  FrequencyAlgo
 Algortihm to obtain the natural frequencies of the model. More...
 
class  FrictionModel
 
class  FrictionResponse
 
class  FullGenEigenSOE
 Dense matrix eigenproblem system of equations. More...
 
class  FullGenEigenSolver
 base class for full (dense) matrix eigenvalue SOE solvers. More...
 
class  FullGenLinLapackSolver
 Lapack based full (dense) general matrix SOE solver. More...
 
class  FullGenLinSOE
 Base class for dense unsymmetric matrix systems of equations. More...
 
class  FullGenLinSolver
 Base class for full (dense) general linear SOE solvers. More...
 
class  FVector
 Element internal forces. More...
 
class  FVectorBeamColumn2d
 Internal forces for a beam-column 2D element. More...
 
class  FVectorBeamColumn3d
 Internal forces for a beam column 3D element. More...
 
class  FVectorData
 Auxiliary class for the internal forces in a beam-column element. More...
 
class  FVectorShell
 Ingernal forces for a shell element. More...
 
class  GammaModulatingFunction
 
class  GammaRV
 
class  GaussLobattoQuadRule1d01
 One-dimensional Gauss-Lobatto quadrature. More...
 
class  GaussModel
 Base class for Gauss integration models. More...
 
class  GaussPoint
 3D position of Gauss points. More...
 
class  GaussQuadRule1d
 One-dimensional Gauss quadrature. More...
 
class  GaussQuadRule1d01
 One-dimensional Gauss quadrature. More...
 
class  GenericSection1d
 ??. More...
 
class  GenericSectionNd
 ?? More...
 
class  GeomSection
 Cross section geometry. More...
 
class  GFunEvaluator
 
class  GFunVisualizationAnalysis
 
class  GlueNodeToElement
 Glue a node to an element. More...
 
class  GradGEvaluator
 
class  GradientProjectionSearchDirection
 
class  Graph
 The Graph class provides the abstraction of a graph, a collection of vertices and edges. The Graph class is a container class which stores and provides access to Vertex objects. The Vertices contain information about the edges in this design. More...
 
class  GraphNumberer
 Numberer for problem's degrees of freedom. More...
 
class  GraphPartitioner
 GraphPartitioner is an abstract base class. Its subtypes are responsible for partioning the vertices of a graph. The partitioning is done in the method partition which sets the colors of the vertices of the graph to colors 1 through numParrtitions. More...
 
class  GroundMotion
 Base class for ground motions. More...
 
class  GroundMotionRecord
 Data from a real earthquake. More...
 
class  GSA_Recorder
 GSA_Recorder is used to create an o/p file which can be read by the Ove Arup's GSA program for postprocessing. More...
 
class  GumbelRV
 
class  Hajjar2D
 XXX?? More...
 
class  HandlerRecorder
 Base class for recorders that get the response of one or more nodes during the analysis. More...
 
class  HardeningMaterial
 HardeningMaterial provides the abstraction for a one-dimensional rate-independent plasticity model with combined isotropic and kinematic hardening. More...
 
class  HessianApproximation
 
class  HHT
 HHT is an algorithmic class for performing a transient analysis using the HHT integration scheme. More...
 
class  HHT1
 The three parameter Hilbert-Hughes-Taylor time-stepping method. More...
 
class  HHTBase
 HHTBase is an algorithmic class for performing a transient analysis using the HHTBase integration scheme. More...
 
class  HHTExplicit
 HHTExplicit is an algorithmic class for performing a transient analysis using the HHTExplicit integration scheme (beta = 0). More...
 
class  HHTGeneralized
 HHTGeneralized is an algorithmic class for performing a transient analysis using the HHTGeneralized integration scheme. More...
 
class  HHTGeneralizedExplicit
 HHTGeneralizedExplicit is an algorithmic class for performing a transient analysis using the HHTGeneralizedExplicit integration scheme. More...
 
class  HHTHybridSimulation
 HHTHybridSimulation is an algorithmic class for performing a transient analysis using the HHTHybridSimulation integration scheme. More...
 
class  HHTRayleighBase
 HHTRayleighBase is an algorithmic class for performing a transient analysis using the HHTRayleighBase integration scheme. More...
 
class  HingeBeamIntegration2d
 ??. More...
 
class  HingeBeamIntegration3d
 ??. More...
 
class  HingeEndpointBeamIntegration
 ??. More...
 
class  HingeMidpointBeamIntegration
 ??. More...
 
class  HingeMidpointBeamIntegration2d
 ??. More...
 
class  HingeMidpointBeamIntegration3d
 ??. More...
 
class  HingeRadauBeamIntegration
 Base class for Radau integration on beam with hinges. More...
 
class  HingeRadauBeamIntegration2d
 Radau integration on beam elements. More...
 
class  HingeRadauBeamIntegration3d
 Radau integration on 3D beams. More...
 
class  HingeRadauTwoBeamIntegration
 Radau integration. More...
 
class  HingeRadauTwoBeamIntegration2d
 ??. More...
 
class  HingeRadauTwoBeamIntegration3d
 ??. More...
 
class  HLRFSearchDirection
 
class  HSConstraint
 ??. More...
 
class  HystereticEnergy
 
class  HystereticMaterial
 HystereticMaterial provides the implementation of a one-dimensional hysteretic model with pinching of both force and deformation, damage due to deformation and energy, and degraded unloading stiffness based on maximum ductility. This is a modified implementation of Hyster2.f90 by Filippou. More...
 
class  ID
 
class  IDVarSize
 
class  ImposedMotionBase
 Base class for prescribed displacements at the nodes. More...
 
class  ImposedMotionSP
 Prescribed value for a single degree of freedom. More...
 
class  ImposedMotionSP1
 Prescribed value over a single degree of freedom. More...
 
class  IncrementalIntegrator
 IncrementalIntegrator is an algorithmic class for setting up the finite element equations in an incremental analysis and for updating the nodal response quantities based on the values in the soln vector. More...
 
class  Inelastic2DYS01
 ??. More...
 
class  Inelastic2DYS02
 ??. More...
 
class  Inelastic2DYS03
 ??. More...
 
class  InelasticYS2DGNL
 Inelastic Element - concentrated hinge model, Fi - Fj interaction at each ends using yield surfaces *. More...
 
class  Information
 Information about an element. More...
 
class  InitialInterpolatedLineSearch
 This performs the search by using a form of linear interpolation to find the best solution. More...
 
struct  intData
 
class  IntegrationPointsCoords
 Stores the coordinates of the integration points. More...
 
class  Integrator
 Base class for the object that performs the integration of physical properties over the domain to form the system stiffness matrix. More...
 
class  IntegratorVectors
 Vectores empleados en varios integrators. More...
 
class  InteractionDiagram
 @ingroup MATSCCDiagInt More...
 
class  InteractionDiagram2d
 @ingroup MATSCCDiagInt More...
 
class  InteractionDiagramData
 @ingroup MATSCCDiagInt More...
 
class  InternalParamsA
 Internal parameters for a p-y material. More...
 
class  InternalParamsIn
 Internal parameters for a p-y material. More...
 
class  InternalParamsLR
 Internal parameters for a p-y material. More...
 
class  InternalParamsLRIn
 Internal parameters for a p-y material. More...
 
class  InterpolatedGroundMotion
 ??. More...
 
class  IntPtrWrapper
 
class  Isolator2spring
 "two-spring isolator" material. This material is based on the two-spring model originally developed by Koh and Kelly to represent the buckling behavior of an elastomeric bearing. The material model has been modified to include material nonlinearity and optional strength degradation. More...
 
class  Isotropic2D01
 ??. More...
 
class  ItpackLinSOE
 ITPACK based systems of equations. More...
 
class  ItpackLinSolver
 ITPACK based linear SOE solver. More...
 
class  J2AxiSymm
 J2 Isotropic hardening material class para axysimmetric problems. More...
 
class  J2PlaneStrain
 J2 Isotropic hardening material class for plane strain problems. More...
 
class  J2PlaneStress
 J2 Isotropic hardening material class for plane stress problems. More...
 
class  J2Plasticity
 J2 Isotropic hardening material class. More...
 
class  J2PlateFiber
 J2 Isotropic hardening material class for plate problems. More...
 
class  J2ThreeDimensional
 J2 Isotropic hardening material class for 3D problems. More...
 
class  Joint2D
 2D joint element. More...
 
class  Joint2DPhysicalProperties
 Physical properties for shells. More...
 
class  Joint3D
 Joint element for three-dimensional problems. More...
 
class  Joint3DPhysicalProperties
 Physical properties for shells. More...
 
class  JonswapSpectrum
 
class  KDTreeElements
 
class  KDTreeNodes
 
class  KEigenIntegrator
 Integrator used to obtain the eigenvalues and eigenvectors of the stiffness matrix. More...
 
class  Kinematic2D01
 2D kinematic yield surface. More...
 
class  Kinematic2D02
 ?? More...
 
class  KooFilter
 
class  KooModulatingFunction
 
class  Kratzig
 
class  KRSeccion
 Stiffness matrix and resultant vector for a section. More...
 
class  KrylovNewton
 KrylovNewton is a class which uses a Krylov subspace accelerator on the modified Newton method. The accelerator is described by Carlson and Miller in "Design and Application of a 1D GWMFE Code" from SIAM Journal of Scientific Computing (Vol. 19, No. 3, pp. 728-765, May 1998). More...
 
class  Lagrange_FE
 Lagrange_FE is a subclass of FE_Element which handles _Constraints using the Lagrange method. More...
 
class  LagrangeConstraintHandler
 Constraint handler for handling constraints using the Lagrange multipliers method. More...
 
class  LagrangeDOF_Group
 A LagrangeDOF_Group object is instantiated by a LagrangeConstraintHandler for every constrained node in the domain. More...
 
class  LagrangeMFreedom_FE
 LagrangeMFreedom_FE is a subclass of FE_Element which handles MFreedom_Constraints using the Lagrange method. More...
 
class  LagrangeMRMFreedom_FE
 LagrangeMRMFreedom_FE is a subclass of FE_Element which handles MRMFreedom_Constraints using the Lagrange method. More...
 
class  LagrangeSFreedom_FE
 LagrangeSFreedom_FE is a subclass of SFreedom_FE which handles SFreedom_Constraints using the Lagrange method. More...
 
class  LaplaceRV
 
class  LegendreBeamIntegration
 cuadratura Gauss-Legendre More...
 
class  LimitStateFunction
 
class  Linea
 Segmento de recta entre dos puntos. More...
 
class  LineaBase
 Base class for 1D entities. More...
 
class  Linear
 performs a linear solution algorihm to solve the equations. More...
 
class  LinearBucklingAlgo
 Algorithm for linear buckling analysis. More...
 
class  LinearBucklingAnalysis
 Linear buckling analysis. More...
 
class  LinearBucklingEigenAnalysis
 Linear buckling analysis (used inside an StaticAnalysis). More...
 
class  LinearBucklingIntegrator
 LinearBucklingIntegrator is an algorithmic class for setting up the finite element equations for a linear buckling analysis. More...
 
class  LinearCrdTransf2d
 LinearCrdTransf2d provides the abstraction of a linear transformation for a spatial frame between the global and basic coordinate systems. More...
 
class  LinearCrdTransf3d
 Linear coordinate transformation. Performs a linear transformation of element stiffness and responses between local and global reference systems. More...
 
class  LinearCyclic
 ??. More...
 
class  LinearSeries
 Linear function over time. More...
 
class  LinearSOE
 Linea system of equations. This is the class definition for LinearSOE. LinearSOE is an abstract base class and thus no objects of it's type can be instantiated. It has pure virtual functions which must be implemented in it's derived classes. LinearSystemOfEqn is an abstraction of the linear system of equation given by : [A]{X} = {B} - {C}, where A is a matrix and B,C and X are vectors. To solve the equation means given A, B and C to find the unknown X such that the equation is satisfied. More...
 
class  LinearSOEData
 Data (size, arrays,...) for linear system of equations. More...
 
class  LinearSOESolver
 Solution of the linear system of equations. More...
 
class  LineSearch
 LineSearch is an abstract base class, i.e. no objects of it's type can be created. Its subclasses seek to find a better solution to R(U)=0 than the solution Ui-1 + delta Ui would give, typically Ui = Ui-1 + factor * delta Ui. More...
 
class  ListRegiones
 Lista de regiones. More...
 
class  ListReinfLayer
 Contenedor (lista) de capas de armadura. More...
 
class  Load
 Base class for loads over nodes or elements. More...
 
class  LoadBalancer
 
class  LoadCaseIter
 ??. More...
 
class  LoadCombination
 Load pattern combination (1.5*PP+1.0*CP+1.6*SC ...). More...
 
class  LoadCombinationGroup
 Load combination container. More...
 
class  LoadControl
 Sets the incremental factor to apply on the loads for each analysis step. More...
 
class  Loader
 Base class for the preprocessor objects that create model entities: nodes, elements, loads, etc. More...
 
class  LoadIter
 Iterator over loads. More...
 
class  LoadLoader
 Lee load patterns desde archivo. Load definition manager. More...
 
class  LoadLoaderMember
 ??. More...
 
class  LoadPath
 LoadPath is an algorithmic class for performing a static analysis using a user defined load path (a user specified lambda path). More...
 
class  LoadPattern
 A LoadPattern object is used to to store reference loads and single point constraints and a TimeSeries function which is used to determine the load factor given the pseudo-time to the model. More...
 
class  LoadPatternIter
 Load pattern iterator. More...
 
class  LobattoBeamIntegration
 Base class for Lobatto integration on beams. More...
 
class  LognormalRV
 
class  LogWEnergy
 ??. More...
 
class  LowOrderBeamIntegration
 
class  MachineBroker
 A MachineBroker is responsible for getting an actor process running on the parallel machine. More...
 
class  MapCadMember
 Container for model entities. More...
 
class  MapCadMemberBase
 Base class for entity containers of the model. More...
 
class  MapCasosActivos
 
class  MapCuerpos
 Body contaainer. More...
 
class  MapEnt
 Geometric entities container (points, lines, surfaces,...). More...
 
class  MapEsquemas2d
 Bidimensional scheme container. More...
 
class  MapEsquemas3d
 Three dimensional scheme container. More...
 
class  MapFields
 Container of field definitions. More...
 
class  MapLineas
 Contenedor de puntos del modelo. More...
 
class  MapLoadPatterns
 Load pattern container. More...
 
class  MapModelWrapper
 Finite element model wrappers container. More...
 
class  MapOfTaggedObjects
 The class is responsible for holding and providing access to objects of type TaggedObject. A map template of the standard template class is used to store the pointers to these objects. More...
 
class  MapOfTaggedObjectsIter
 MapOfTaggedObjectsIter is an iter for returning the TaggedObjects of a storage objects of type MapOfTaggedComponents. More...
 
class  MapPuntos
 Point container. More...
 
class  MapSet
 Sets container. More...
 
class  MapSisRef
 Reference systems container. More...
 
class  MapSoluMethod
 Solution methods container. More...
 
class  MapSurfaces
 Contenedor de puntos del modelo. More...
 
class  MapTrfGeom
 Contenedor de puntos del modelo. More...
 
class  MapUniformGrids
 Uniform grid container. More...
 
class  Material
 Base class for materials. More...
 
class  MaterialLoader
 Material handler (definition, searching,...). More...
 
class  MaterialResponse
 Recorder for material response. More...
 
class  MaterialVector
 Material pointer container. It's used by elements to store materials for each integration point. More...
 
class  MatParameter
 
class  MatPoint3D
 Integration point on three-dimensional space. More...
 
class  Matrix
 
class  MatrixCommMetaData
 Data about the position, size,... of the object to transmit. More...
 
class  MatrixOperations
 
class  MatrizPtrBase
 Base class for matrices of pointers to nodes, elements and points. More...
 
class  MatrizPtrElem
 Matrix of pointers to elements. More...
 
class  MatrizPtrNod
 Matriz de pointers to nodes. More...
 
class  MatrizPtrPnt
 Matriz de pointers to puntos. More...
 
class  MaxNodeDispRecorder
 A MaxNodeDispRecorder is used to determine the max nodal displacement at a collection of nodes over an analysis. (between commitTag of 0 and last commitTag). More...
 
class  MDEvolutionLaw
 ??. More...
 
class  MDPotentialSurface
 ??. More...
 
class  MDPotentialSurface01
 ??. More...
 
class  MDYieldSurface
 ??. More...
 
class  MEDBaseInfo
 Base class for infomation objects. More...
 
class  MEDCellBaseInfo
 Basic information about mesh cells. More...
 
class  MEDCellInfo
 Information about mesh cells (conectivity,...). More...
 
class  MEDDblFieldInfo
 Information about an scalar field defined on a mesh subset. More...
 
class  MEDFieldInfo
 Information about a field defined over a mesh subset. More...
 
class  MEDGaussModel
 Information about Gauss model. More...
 
class  MEDGroupInfo
 Information about node and element sets. More...
 
class  MEDIntFieldInfo
 Information about field defined over a mesh subset. More...
 
class  MEDMapConectividad
 Information about mesh cells connectivity. More...
 
class  MEDMapIndices
 Map between the indexes in XC and in MEDMEM. More...
 
class  MEDMapNumCeldasPorTipo
 Number of cells de cada tipo. More...
 
class  MEDMesh
 Envoltorio para el objeto MESHING de MED. More...
 
class  MEDMeshing
 Envoltorio para el objeto MESHING de MED. More...
 
class  MEDObject
 Base class for MED objects. More...
 
class  MEDTFieldInfo
 Iformation about a field defined over a mesh subset. More...
 
class  MEDVertexInfo
 Information about mesh vertex. More...
 
class  Mehanny
 
class  MembranePlateFiberSection
 Fiber model for plate/membrane materials. More...
 
class  MeritFunctionCheck
 
class  Mesh
 Finite element mesh. More...
 
class  MeshComponent
 Base class for nodes and elements (mesh components). More...
 
class  MeshComponentContainer
 Base class for the element and constraint containers. More...
 
class  MeshCompRecorder
 Base class for mesh components recorders. More...
 
class  MeshEdge
 Mesh edge. More...
 
class  MeshEdges
 Element edge container. More...
 
class  MeshRegion
 
class  Message
 Message between processes. More...
 
class  Metis
 type of GraphPartitioner which uses 'METIS - Unstructured Graph Partitioning And Sparse Matrix Ordering System', developed by G. Karypis and V. Kumar at the University of Minnesota. The metis files are found in metis-2.0 which were downloaded. More...
 
class  MFreedom_Constraint
 Multi-freedom constraint. Objectt of this class store the information for a multifreedom constraint. A multifreedom constraint relates certain dof at a constrained node to be related to certain dof at a retained node: {Uc} = [Ccr] {Ur}. More...
 
class  MFreedom_ConstraintBase
 Base class for mult-freedom constraints. More...
 
class  MFreedom_ConstraintIter
 Iterator over multi-freedom constraints. More...
 
class  MFreedom_FE
 ?? More...
 
class  MFreedom_Joint
 Base class for joint constraints. More...
 
class  MFreedom_Joint2D
 ??. More...
 
class  MFreedom_Joint3D
 ??. More...
 
class  MidDistanceBeamIntegration
 
class  MillMachineBroker
 
class  MinMaxMaterial
 Stores max and min strain values. More...
 
class  MinUnbalDispNorm
 Specifies the incremental load factor such that the residual displacement norm in minimized. More...
 
class  ModalAnalysis
 Modal analysis. More...
 
class  ModelBuilder
 
class  ModelGraph
 Base class for model graph. More...
 
class  ModelWrapper
 Wrapper for the finite element model "seen" from the solver. The model wrapper is definied by: More...
 
class  ModifiedNewton
 Uses the tangent stiffness matrix computed in the first iteration until convergence is achieved. More...
 
class  ModNewtonRootFinding
 
class  ModulatingFunction
 
class  MooneyRivlinSimoWEnergy
 ??. More...
 
class  MooneyRivlinWEnergy
 ??. More...
 
class  MotionHistory
 Data that define acceleration, velocities and displacements due to a earthquake. More...
 
class  MovableBJTensor
 BJTensor that can move between processes. More...
 
class  MovableContainer
 Container that can move between processes. More...
 
class  MovableID
 ID that can move between processes. More...
 
class  MovableMap
 Template class for maps that can move between processes. More...
 
class  MovableMatrices
 Matrices that can move between objects. More...
 
class  MovableMatrix
 Matrix that can move between processes. More...
 
class  MovableObject
 Object that can move between processes. More...
 
class  MovableString
 String that can move between processes. More...
 
class  MovableStrings
 Strings that can move between processes. More...
 
class  MovableVector
 Vector that can move between processes. More...
 
class  MovableVectors
 Vector can move between processes. More...
 
class  MPBase_FE
 ?? More...
 
class  MPI_Channel
 MPI_Channel is a sub-class of channel. It is implemented with Berkeley stream sockets using the TCP protocol. Messages delivery is garaunteed. Communication is full-duplex between a pair of connected sockets. More...
 
class  MPI_ChannelAddress
 It is used to encapsulate the addresses used to send/recv messages using the MPI library. More...
 
class  MPI_MachineBroker
 MPI_MachineBroker is the broker responsible for monitoring the usage of the processes in an mpi run. More...
 
class  MPSPBaseFE
 Base class for MFreedom_FE y SFreedom_FE. More...
 
class  MRMFreedom_Constraint
 Multiple retained nodes constraint. More...
 
class  MRMFreedom_ConstraintIter
 Iterador over multiple retained nodal constraints. More...
 
class  MRMFreedom_FE
 ?? More...
 
class  MultiaxialCyclicPlasticity
 ??. More...
 
class  MultiaxialCyclicPlasticity3D
 ??. More...
 
class  MultiaxialCyclicPlasticityAxiSymm
 ??. More...
 
class  MultiaxialCyclicPlasticityPlaneStrain
 ??. More...
 
class  MultiLinearKp
 XXX??. More...
 
class  MultiSupportPattern
 The Multi-Support pattern allows similar or different prescribed ground motions to be input at various supports in the structure. More...
 
class  MultiYieldSurface
 ??. More...
 
class  MVFOSMAnalysis
 
class  MyRCM
 Class which performs the Reverse Cuthill-McKee numbering scheme on the vertices of a graph. This is done by invoking the number() method with the Graph to be numbered. More...
 
class  MySqlDatastore
 
class  NarrowBandSpectrum
 
class  NatafProbabilityTransformation
 
class  NDAdaptorMaterial
 ??. More...
 
class  nDarray
 
class  nDarray_rep
 
class  NDMaterial
 Base class for 2D and 3D materials. More...
 
class  NDMaterialPhysicalProperties
 Physical properties for solid mechanics. More...
 
class  NEES_table
 
class  NEESData
 
class  NeoHookeanCompressible3D
 ??. More...
 
class  NeoHookeanWEnergy
 ??. More...
 
class  NewElement
 Element prototype. More...
 
class  Newmark
 The two parameter time-stepping method developed by Newmark. More...
 
class  Newmark1
 Newmark1 is an algorithmic class for performing a transient analysis using the Newmark1 integration scheme. More...
 
class  NewmarkBase
 The two parameter time-stepping method developed by NewmarkBase. More...
 
class  NewmarkBase2
 ??. More...
 
class  NewmarkExplicit
 NewmarkExplicit is an algorithmic class for performing a transient analysis using the explicit Newmark integration scheme (beta = 0). More...
 
class  NewmarkHybridSimulation
 NewmarkHybridSimulation is an algorithmic class for performing a transient analysis using the Newmark integration scheme. More...
 
class  NewmarkSensitivityIntegrator
 
class  NewtonBased
 Uses the tangent stiffness matrix on each iteration (with or without updating) until convergence is achieved. More...
 
class  NewtonCotesBeamIntegration
 Newton-Cotes integration on beam elements. More...
 
class  NewtonLineSearch
 performs a Newton-Raphson with line search solution algorithm in solving the equations as outline in Crissfields book. More...
 
class  NewtonRaphson
 Uses the tangent stiffness matrix on each iteration until convergence is achieved. More...
 
class  NewUniaxialMaterial
 ??. More...
 
class  NineFourNodeQuadUP
 9-4-node (9 node for solid and 4 node for fluid) plane strain element for solid-fluid fully coupled analysis. This implementation is a simplified u-p formulation of Biot theory (u - solid displacement, p - fluid pressure). Each element node has two DOFs for u and 1 DOF for p. More...
 
class  NineNodeMixedQuad
 Nine node quad. More...
 
class  NLBeamColumn2d
 Nonlinear beam-column bidimensional elements. More...
 
class  NLBeamColumn3d
 3D materially nonlinear flexibility based frame element. More...
 
class  NLForceBeamColumn2dBase
 
class  NLForceBeamColumn3dBase
 Base clas for 3D force beam column elements with SeccionBarraPrismatica type material. More...
 
class  NMPointCloud
 (N,M) point set More...
 
class  NMPointCloudBase
 (N,M) point set base More...
 
class  NMyMzPointCloud
 (N,My,Mz) point set More...
 
class  NodalLoad
 Load over a node. More...
 
class  NodalLoadIter
 Iterador sobre las nodal loads. More...
 
class  Node
 Mesh node. More...
 
class  NodeAccelVectors
 Vectors that store trial and commited values of the node acceleration. More...
 
class  NodeDispVectors
 Vectores to store trial and commited values («commited») on node displacements. More...
 
class  NodeIter
 Iterador sobre el conteedor de nodos. More...
 
class  NodeLoader
 Node creation manager. More...
 
class  NodeLocations
 
class  NodeLocker
 Single freedom constraints that make part of a load pattern. More...
 
class  NodeLockerIter
 Iterador sobre los objetos de tipo NodeLocker. More...
 
class  NodeLockers
 NodeLocker container. More...
 
class  NodePos
 Node position for its use in the KDTree. More...
 
class  NodePropRecorder
 
class  NodePtrs
 Pointers to nodes. More...
 
class  NodePtrsWithIDs
 Node pointer container for elements. More...
 
class  NodeRecorder
 Recording of specified nodal DOF responses for the specified nodes. More...
 
class  NodeRecorderBase
 Base class for the node recorders. More...
 
class  NodeVectors
 Vectores to store trial and commited values of node displacement, velocity, etc. More...
 
class  NodeVelVectors
 Vectores to store trial and commited values of node velocity. More...
 
class  NormalizedPeak
 
class  NormalRV
 
class  NullEvolution
 Useful for declaring inner-surfaces or pinching surfaces or just plain elastic-perfectly plastic surfaces that do not evolve. More...
 
class  NullPlasticMaterial
 
class  NullYS2D
 Null 2D yield surface. More...
 
class  ObjectBroker
 Base class for brokers. More...
 
class  ObjWithRecorders
 Objeto capaz de gestionar Recorders. More...
 
class  OgdenSimoWEnergy
 ??. More...
 
class  OgdenWEnergy
 ??. More...
 
class  OgdenWEnergyBase
 ??. More...
 
class  OpenSeesGFunEvaluator
 
class  OpenSeesGradGEvaluator
 
class  OPS_Stream
 
class  OptimalityConditionReliabilityConvergenceCheck
 
class  OptimizationAnalysis
 
class  OracleDatastore
 
class  Orbison2D
 Orbison 2D yield surface. More...
 
class  OutCrossingAnalysis
 
class  ParallelMaterial
 Parallel connected materials. More...
 
class  ParallelNumberer
 The ParallelNumberer numbers the dof of a partitioned domain, where the partitions are on different processors and each processor has a ParallelNumberer. The ParalellNumberer sitting on P0, collects each partition graph from P1 through Pn-1, merges them into 1 large graph, & then numbers this graph. The ParallelNumberers sitting on P1 through Pn-1 then receive the mapping info for the dof tag and dof numbering from P0. More...
 
class  ParamAgotTN
 Parameter that define the ultimate limit states of a RC section under normal stresses. More...
 
class  Parameter
 
class  ParameterIDBeamIntegration
 Integration points at fixed locations. More...
 
class  ParameterPositioner
 
class  ParametricReliabilityAnalysis
 
class  ParetoRV
 
class  ParkAng
 
class  ParticlePos3d
 Natural coordinates of an element's particle. More...
 
class  PartitionedDomain
 Partitioned domain. More...
 
class  PartitionedDomainEleIter
 
class  PartitionedDomainSubIter
 
class  PartitionedModelBuilder
 
class  PathIndependentMaterial
 PathIndependentMaterial uses a UniaxialMaterial object to represent a path-independent uniaxial material. Since it is path-independent, no state information is stored by PathIndependentMaterial. More...
 
class  PathSeries
 Time-dependent function that linear interpolates the load factor using user specified control points provided in a vector object. the points in the vector are given at regular time increments pathTimeIncr apart. More...
 
class  PathSeriesBase
 Base class for time-dependent functions defined by a series of points (ti,fi). More...
 
class  PathTimeSeries
 Time-dependent function that linear interpolates the load factor using user specified control points provided in a vector object. the points in the vector are given at time points specified in another vector. More...
 
class  PatternRecorder
 A PatternRecorder records loads values from a LoadPattern. More...
 
class  PBowlLoading
 ??. More...
 
class  PDeltaCrdTransf2d
 PDeltaCrdTransf2d provides the abstraction of a linear transformation for a spatial frame between the global and basic coordinate systems. More...
 
class  PDeltaCrdTransf3d
 PDeltaCrdTransf3d provides the abstraction of a linear transformation for a spatial frame between the global and basic coordinate systems. More...
 
class  PeakOriented2D01
 ?? More...
 
class  PeakOriented2D02
 Grows/shrinks one side while keeping the diametrically opposite end the same. Kp_isoXPos = Kp_isoXNeg = (should be) Kp_kinX Since kinematic is function of back-stress and isotropic is a function of plastic-strains - calibration will be difficult. More...
 
class  PenaltyConstraintHandler
 PenaltyConstraintHandler is a constraint handler deals with both single and multi point constraints using the penalty method. for each element and degree-of-freedom at a node it constructs regular FE_Element and DOF_Groups; for each SFreedom_Constraint and MFreedom_Constraint PenaltySFreedom_FE and PenaltyMFreedom_FE elements are created. More...
 
class  PenaltyMFreedom_FE
 PenaltyMFreedom_FE is a subclass of FE_Element which handles MFreedom_Constraints using the penalty method. More...
 
class  PenaltyMRMFreedom_FE
 PenaltyMRMFreedom_FE is a subclass of FE_Element which handles MRMFreedom_Constraints using the penalty method. More...
 
class  PenaltySFreedom_FE
 PenaltySFreedom_FE is a subclass of SFreedom_FE which handles SFreedom_Constraints using the penalty method. More...
 
class  PeriodicNewton
 PeriodicNewton is a class which performs a Periodic Newton-Raphson solution algorihm in solving the equations. More...
 
class  PeriodSeries
 Periodic function over time. More...
 
class  PetscSOE
 PETSC based system of equations. More...
 
class  PetscSolver
 PETSC library based SOE solver. More...
 
class  PetscSparseSeqSolver
 PETSC based sparse general matrix SOE solver. More...
 
class  PhysicalProperties
 Base class for element's physical properties. More...
 
class  Pinching
 ??. More...
 
class  Pinching4Material
 ??. More...
 
class  PinchingDamage
 ??. More...
 
class  Pivots
 Pivot positions computed for a bending plane. More...
 
class  PivotsUltimateStrains
 Definition of ultimate strains for the pivots. More...
 
class  PlainHandler
 Trivial constraint handler. More...
 
class  PlainNumberer
 Trivial DOF numberer. More...
 
class  PlaneStressMaterial
 Material for plane stress problems. More...
 
class  PlasticHardening2D
 ?? More...
 
class  PlasticHardeningMaterial
 Plastic material with strain hardening. More...
 
class  PlasticLengthsBeamIntegration
 ??. More...
 
class  PlateBase
 Base class for bidimensional membrane/plate/shell materials. More...
 
class  PlateFiberMaterial
 Builds a material that can be used in a plate fiber from its definition as three-dimensional material. More...
 
class  Pnt
 Punto (KPoint). More...
 
class  PointsSpectrum
 
class  PolakHeSearchDirectionAndMeritFunction
 
class  Positioner
 
class  PotentialSurface
 The goal is to create a platform for efficient and easy implemetation of any elasto-plastic constitutive model. More...
 
class  PQyzBase
 Base class for PySimple1 y QzSimple1. More...
 
class  Preprocessor
 Finite element model generation tools. More...
 
class  PressureDependentElastic3D
 ??. More...
 
class  PressureDependMultiYield
 ??. More...
 
class  PressureDependMultiYield02
 ?? More...
 
class  PressureDependMultiYieldBase
 ??. More...
 
class  PressureIndependMultiYield
 ??. More...
 
class  PressureMultiYieldBase
 ??. More...
 
class  ProbabilityTransformation
 
class  ProblemaEF
 Finite element problem. More...
 
class  ProcSolu
 Solution procedure for the finite element problem. More...
 
class  ProcSoluControl
 Container for the objects that control the solution procedure. More...
 
class  profilematrix
 
class  profilematrix_rep
 
class  ProfileSPDLinDirectBase
 Base class for profile matris linear SOE solvers. More...
 
class  ProfileSPDLinDirectBlockSolver
 solves a ProfileSPDLinSOE object using the LDL^t factorization. More...
 
class  ProfileSPDLinDirectSkypackSolver
 Skypakc based linear SOE solver. More...
 
class  ProfileSPDLinDirectSolver
 It solves a ProfileSPDLinSOE object using the LDL^t factorization. More...
 
class  ProfileSPDLinDirectThreadSolver
 solves a ProfileSPDLinSOE object using the LDL^t factorization (threaded version). More...
 
class  ProfileSPDLinSOE
 Profile matrix system of equations. More...
 
class  ProfileSPDLinSolver
 Base class for profile matrix linear SOE solvers. More...
 
class  ProfileSPDLinSubstrSolver
 Some kind of profile matrix linear SOE solver. More...
 
class  PropRecorder
 
class  ProtoArcLength
 Base class for arc length integrators. More...
 
class  ProtoBeam2d
 Base class for 2D beam elements. More...
 
class  ProtoBeam3d
 Base class for 3D beams. More...
 
class  ProtoElementLoader
 Finite element creation. More...
 
class  ProtoTruss
 Base class for truss elements. More...
 
class  PseudoTimeTracker
 Registro del tiempo. More...
 
class  PtrCommMetaData
 Data about the position, size,... of the pointer to transmit. More...
 
class  PulseBaseSeries
 Base class for pulse type time series. More...
 
class  PulseSeries
 Pulse type function. More...
 
class  PYBase
 Material que representa una curva p-y. More...
 
class  PyLiq1
 ??. More...
 
class  PySimple1
 Material que representa una curva p-y. More...
 
class  PySimple1Gen
 ??. More...
 
class  QuadBase4N
 Base class for 4 node quads. More...
 
class  QuadBase9N
 Base class for nine node quads. More...
 
class  QuadCell
 Quadrilateral cell. More...
 
class  QuadraticCyclic
 ??. More...
 
class  QuadRule
 Integration rule (quadrature). More...
 
class  QuadRule1d
 Base class for one-dimesional integrations rules (quadratures). More...
 
class  QuadRule1d01
 One-dimensional quadrature. More...
 
class  QuadSurface
 Quadrangle defined by its four vertices. More...
 
class  QzSimple1
 Material que representa la resistencia por fuste de un pilote. More...
 
class  RadauBeamIntegration
 Base class for Radau integration on beam elements. More...
 
class  RandomNumberGenerator
 
class  RandomVariable
 
class  RandomVariablePositioner
 
class  RawConcrete
 Base class for concrete materials. More...
 
class  RayleighBase
 Base class for Rayleigh integrators. More...
 
class  RayleighDampingFactors
 Rayleigh damping factors. More...
 
class  RayleighRV
 
class  RCM
 Class designed to perform the Reverse Cuthill-McKee numbering scheme on the vertices of a graph. This is done by invoking the number() method with the Graph to be numbered. More...
 
class  Recorder
 An Recorder object is used in the program to store/restore information at each commit(). More...
 
class  RectangularSeries
 Pulso rectangular. More...
 
class  Reflection
 Reflection transformation. More...
 
class  RegionSecc
 Region of a section that corresponds with a material. More...
 
class  RegulaFalsiLineSearch
 performs the search for U(i+1) = U(i) + eta * deltaU(i) by regula falsi method to find the best solution. More...
 
class  ReinfBar
 Reinforcing bar. More...
 
class  ReinfLayer
 Rebar layer. More...
 
class  ReinforcingSteel
 ??. More...
 
class  ReleaseHeavierToLighterNeighbours
 
class  ReliabilityAnalysis
 
class  ReliabilityConvergenceCheck
 
class  ReliabilityDomain
 
class  ReliabilityDomainComponent
 
class  RespFiberSectionShear3d
 
class  RespMembraneMaterial
 
class  Response
 
class  ResponseId
 Stiffness material contribution response identifiers. More...
 
class  ResponseQuantities
 Response quantities. More...
 
class  RespPlateMaterial
 
class  RespPMz
 
class  RespPMzMy
 
class  RespPMzMyT
 
class  RespPMzV
 
class  RespPMzVyMyVzT
 
class  RespPVyMz
 
class  RespShellMaterial
 
class  RespVyP
 
class  RgQuadCell
 Region of a section that creates quadrilateral cells. More...
 
class  RgSccCirc
 Circular shaped patch. More...
 
class  RgSccPoligono
 
class  RgSccQuad
 Quad that discretizes in quad cells. More...
 
class  RigidBase
 Base class for the "rigid body motion" conditions. More...
 
class  RigidBeam
 Imposes a rigid body motion to the nodes of the rigid beam. More...
 
class  RigidDiaphragm
 Imposes a rigid body motion to the nodes on included in the diaphragm . More...
 
class  RigidRod
 constructs MFreedom_Constraint objects for a rigid rod, all translational dof are constrained to be equal at the retained and constarined nodes. More...
 
class  RMC01PotentialSurface
 Functions for rounded Mohr-Coulomb potential function. More...
 
class  RMC01YieldSurface
 Functions for rounded Mohr-Coulomb yield function. More...
 
class  RootFinding
 
class  Rotation
 Rotation transformation. More...
 
class  SamplingAnalysis
 
class  Scaling
 Scale transformation. More...
 
class  SearchDirection
 
class  SearchWithStepSizeAndStepDirection
 
class  SecantLineSearch
 performs the search for U(i+1) = U(i) + eta * deltaU(i) by using the secant method to find the best solution. More...
 
class  SecantRootFinding
 
class  SeccionBarraPrismatica
 Base class for beam-column cross sections. Constitutive equations of the section. More...
 
class  SeccionInerte
 Cross-section representation able to return mechanical propertis a area, moments of inertia,... More...
 
class  SectionAggregator
 SectionAggregator decorates an MP section (couple bending and axial) with an uncoupled shear relation. More...
 
class  SectionFDPhysicalProperties
 Physical properties for shells. More...
 
class  SectionForceDeformation
 Base class for force deformation section models. Constitutive equations of the section. More...
 
class  SectionMatrices
 Matrices for each section (used in BeamColumnWithSectionFD) More...
 
class  SectionRepres
 Material distribution on a cross section. More...
 
struct  SecuenciaLados
 Order in edges of an hexaedron face. More...
 
class  Segment
 Segment de recta entre dos puntos. More...
 
class  SensitivityAlgorithm
 
class  SensitivityIntegrator
 
class  SeriesMaterial
 Serially connected uniaxial materials. More...
 
class  Set
 Object set. More...
 
class  SetBase
 Base de las clases Set y SetEstruct. More...
 
class  SetEstruct
 structured set, i. e. a set that can return a pointer a to a node or an element from its indices i,j and k. More...
 
class  SetFila
 Set of objects in a row. More...
 
class  SetFilaI
 Set of objecst in a row. More...
 
class  SetFilaJ
 Objects in a row. More...
 
class  SetFilaK
 Set of objects in a row. More...
 
class  SetMeshComp
 Set of mesh components (nodes, elements and constraints). More...
 
class  SFreedom_Constraint
 Single freedom constraint. More...
 
class  SFreedom_ConstraintIter
 Iterator over single freedom constraints. More...
 
class  SFreedom_FE
 ?? More...
 
class  Shadow
 
class  ShadowPetscSOE
 ??. More...
 
class  ShadowSubdomain
 
class  ShedHeaviest
 
class  ShellBData
 Auxiliary data for shell elements. More...
 
class  ShellCorotCrdTransf3d
 Base class for 3D coordinate transformation. More...
 
class  ShellCrdTransf3dBase
 Base class for 3D coordinate transformations. More...
 
class  ShellLinearCrdTransf3d
 Base class for small displacement 3D coordinate transformations. More...
 
class  ShellMecLoad
 Mechanical load (forces) over shell elements. More...
 
class  ShellMITC4
 MIT C4 shell elements. More...
 
class  ShellMITC4Base
 Base class for MIT C4 shell elements. More...
 
class  ShellNL
 Lagrangian shell element with membrane and drill. More...
 
class  ShellStrainLoad
 Load due to restricted material expansion or contraction on Shell elements. More...
 
class  ShellUniformLoad
 Uniform load over shell elements. More...
 
class  ShiftedExponentialRV
 
class  ShiftedRayleighRV
 
class  SimoPisterWEnergy
 ??. More...
 
class  Simple1GenBase
 ??. More...
 
class  SimpleDOF_Iter
 Iterator over the degrees of freedom of the analysis model. More...
 
class  SimpleFE_Iter
 Iterator over the model finite elements. More...
 
class  SimpleNumberer
 Triviel DOF numberer. More...
 
class  SimulatedRandomProcessSeries
 ??. More...
 
class  SingleBar
 Single rebar (not included in a reinforcement layer). More...
 
class  SingleDomAllSFreedom_Iter
 
class  SingleDomEleIter
 
class  SingleDomLC_Iter
 
class  SingleDomMFreedom_Iter
 
class  SingleDomMRMFreedom_Iter
 
class  SingleDomNodIter
 
class  SingleDomSFreedom_Iter
 
class  SingleDomTIter
 
class  SingleFPSimple2d
 
class  SingleFPSimple3d
 
class  SisRef
 Reference system to be used for simpliflying the definition of point positions. More...
 
class  SisRefCartesianas3d
 Three-dimensional reference system. More...
 
class  SisRefScc
 Reference system used for make easier definining point positions. More...
 
class  SisRefSccCartesianas2d
 Bidimensional reference system for a section. More...
 
class  skymatrix
 
class  SmallDispCrdTransf2d
 Base class for small displacements 2D coordinate transformations. More...
 
class  SmallDispCrdTransf3d
 Base class for small displacements 3D coordinate transformations. More...
 
class  SocketAddress
 It is used to encapsulate the addresses used to send/recv messages using Berkeley sockets. SocketAddress is needed as a friend by UDP_Socket & TCP_Socket. More...
 
class  SolidMech2D
 Physical properties for solid mechanics. More...
 
class  SoluMethod
 Solution procedure for the finite element problem. The solution procedure is definde by specifiying: More...
 
class  SolutionAlgorithm
 Base class for solution algorithms. More...
 
class  Solver
 Equation solver. More...
 
class  SORMAnalysis
 
class  SparseGenColLinSOE
 Sparse nonsymmetric matrix linear system of equations. More...
 
class  SparseGenColLinSolver
 Base class for sparse general matrix linear SOE solver. More...
 
class  SparseGenRowLinSOE
 Sparse nonsymmetric matrix linear system of equations. More...
 
class  SparseGenRowLinSolver
 Base class for sparse general matrix linear SOE solvers. More...
 
class  SparseGenSOEBase
 Sparse unsymmetric matris system of equations. More...
 
class  SparseSOEBase
 Base class for sparse matrix systems of equations. More...
 
class  Spectrum
 
class  Spot
 Point object for section geometry definition. More...
 
class  Spring
 
class  SQLiteDatastore
 
class  SQPsearchDirectionMeritFunctionAndHessian
 
class  StandardEigenAlgo
 Standard eigenvalues algorithm. More...
 
class  StandardLinearOscillatorAccelerationFilter
 
class  StandardLinearOscillatorDisplacementFilter
 
class  StandardLinearOscillatorVelocityFilter
 
class  StandardReliabilityConvergenceCheck
 
class  StandardStream
 
class  StaticAnalysis
 performs a static analysis on the FE_Model. More...
 
class  StaticDomainDecompositionAnalysis
 StaticDomainDecompositionAnalysis is a subclass of DomainDecompositionAnalysis used to perform a static analysis step on a subdomain. More...
 
class  StaticIntegrator
 Base class for static integrators. More...
 
class  StaticSensitivityIntegrator
 
class  Steel01
 Uniaxial material model for steel. More...
 
class  Steel02
 Uniaxial material for steel. Menegotto-Pinto steel model with Filippou isotropic hardening. More...
 
class  Steel03
 Steel 03 uniaxial material. More...
 
class  SteelBase
 Base class for steel uniaxial materials. More...
 
class  SteelBase0103
 Base class for Steel01 and Steel03. More...
 
class  StepSizeRule
 
class  StoFibras
 Contenedor de fibras. More...
 
class  StraightReinfLayer
 Set of rebars distributed along a segment. More...
 
class  straintensor
 Strain tensor. More...
 
class  stresstensor
 
class  Subdomain
 
class  SubdomainAnalysis
 SubdomainAnalysis is a subclass of AnalysisAnalysis, it is used when performing a domain decomposition analysis. It provides methods which can be invoked by a subdomain to perform the numerical computations required. More...
 
class  SubdomainIter
 
class  SubdomainNodIter
 
class  SubstructuringAnalysis
 SubstructuringAnalysis is a subclass of Analysis, it is used when performing a domain decomposition analysis. It provides methods which can be invoked by a subdomain to perform the numerical computations required. More...
 
class  SuperLU
 SuperLU based sparse general matrix linear SOE solver. More...
 
class  SwapHeavierToLighterNeighbours
 
class  SymArpackSOE
 Arpack system of equations for symmetric matrices. More...
 
class  SymArpackSolver
 Arpack based symmetric matrix eigenvalue SOE solver. More...
 
class  SymBandEigenSOE
 Band symmetric matrix eigenvaules system of equations. More...
 
class  SymBandEigenSolver
 Base class for symmetric band matrix eigenvalue SOE solvers. More...
 
class  SymSparseLinSOE
 Sparse symmetric matrix systems of equations. More...
 
class  SymSparseLinSolver
 Solver for symmetric sparse linear SOE. More...
 
class  SystemAnalysis
 
class  SystemOfEqn
 System of equations base class. More...
 
class  T2Vector
 Tensor de segundo orden. More...
 
class  TaggedObject
 Object idenfied by an integer (tag). More...
 
class  TaggedObjectIter
 An TaggedObjectIter is an iter for returning the Components of an object of class TaggedObjectStorage. It must be written for each subclass of TaggedObjectStorage (this is done for efficiency reasons), hence the abstract base class. More...
 
class  TaggedObjectStorage
 TaggedObjectStorage. A TaggedObjectStorage object a container object used to hold objects of type TaggedObject; each object of which has some UNIQUE identifier. More...
 
class  TclGFunEvaluator
 
class  TclMatlabGFunEvaluator
 
class  TCP_Socket
 TCP_Socket is a sub-class of channel. It is implemented with Berkeley stream sockets using the TCP protocol. Messages delivery is garaunteed. Communication is full-duplex between a pair of connected sockets. More...
 
class  TCP_SocketNoDelay
 TCP_SocketNoDelay is a sub-class of channel. It is implemented with Berkeley stream sockets using the TCP protocol. Messages delivery is garaunteed. Communication is full-duplex between a pair of connected sockets. More...
 
class  Template3Dep
 3 More...
 
class  TensorCommMetaData
 Data about the address, size,... of the tensor to transmit. More...
 
class  ThreadedSuperLU
 Threaded SuperLU based sparse general matrix linear SOE solver. More...
 
class  Timer
 
class  TimeSeries
 Time variation of loads.A TimeSeries object is used to determine the load factor to be applied to the loads in a pettern. to the model. More...
 
class  TimeSeriesIntegrator
 Time integration of time series. A TimeSeriesIntegrator describes the numerical integration of a ground motion record used in a dynamic analysis. More...
 
class  TotalLagrangianFD20NodeBrick
 Twenty node hexahedron with lagrangian formulation. More...
 
class  TransfCooLoader
 Manager for the creation/deletion of coordinate transformations. More...
 
class  TransformationConstraintHandler
 TransformationConstraintHandler is a constraint handler for handling constraints using the Transformation method. For each element and degree-of-freedom at a node it constructs regular FE_Element and DOF_Groups if there is no SFreedom_Constraint or MFreedom_Constraint constraining an elements node or the node; otherwise a TransformationFE element and a TransformationDOF_Group are created. More...
 
class  TransformationDOF_Group
 A TransformationDOF_Group object is instantiated by the TransformationConstraintHandler for every node in the domain which is constrained by an MFreedom_Constraint or an SFreedom_Constrant. More...
 
class  TransformationFE
 TransformationFE objects handle MFreedom_Constraints using the transformation method T^t K T. SFreedom_Constraints are handled by the TransformationConstraintHandler. More...
 
class  TransientAnalysis
 Analysis of the time-dependent response of the model. More...
 
class  TransientDomainDecompositionAnalysis
 Transient analysis witn domain decomposition. More...
 
class  TransientIntegrator
 Base class for dynamic equations of motion integrators. More...
 
class  Translation
 Translation transformation. More...
 
class  TrapezoidalBeamIntegration
 Trapezoidal integration scheme. More...
 
class  TrapezoidalModulatingFunction
 
class  TrapezoidalTimeSeriesIntegrator
 integrates a ground motion TimeSeries using the trapezoidal rule. More...
 
class  TrfGeom
 
class  Tri31
 3 node triangle. More...
 
class  TriangCell
 Triangle shaped cell for section discretization. More...
 
class  TriangleSeries
 Serie de ondas triangulares. More...
 
class  TriBase3N
 Base class for 3 node triangles. More...
 
class  TriFCYieldSurface
 Yield surface is based on article by Menetrey, P. and William, K.J. published in 1995 in ACI Structural Journal pp 311-318. Purpose of the Yield surface is to model triaxial strenght of concrete. More...
 
class  TrigSeries
 Trigonometric functions over time. A TrigSeries object provides a sine time series. the factor is given by the pseudoTime (x), pulse period (T), phase shift (phi), i.e. by sin(2*PI*(x-xo)/T + phi), and a constant factor provided in the constructor, the duration by tStart and tFinal;. More...
 
class  TritrizPtrBase
 "Tritriz" de pointers to objetos. More...
 
class  TritrizPtrElem
 "Tritriz" of pointers to elements. More...
 
class  TritrizPtrNod
 "Tritriz" of pointers to elements. More...
 
class  TritrizPtrPnt
 "Tritriz" of elment pointers. More...
 
class  Truss
 Barra articulada. More...
 
class  TrussBase
 Base class for truss elements. More...
 
class  TrussSection
 Truss element with SectionForceDeformation material. More...
 
class  TrussStrainLoad
 Load due to restricted material expansion or contraction on truss elements. More...
 
class  Twenty_Node_Brick
 Hexaedro de veinte nodos. More...
 
class  TwentyEightNodeBrickUP
 Hexaedro de veintiocho nodos. More...
 
class  TwentyNodeBrick
 Hexaedro de veinte nodos. More...
 
class  TwentyNodeBrick_u_p_U
 Hexaedro de veinte nodos. More...
 
class  TwentySevenNodeBrick
 Twenty seven node hexahedron with lagrangian formulation. More...
 
class  Type1LargestValueRV
 
class  Type1SmallestValueRV
 
class  Type2LargestValueRV
 
class  Type3SmallestValueRV
 
class  TzLiq1
 ??. More...
 
class  TzSimple1
 Material que representa una curva t-z. More...
 
class  TzSimple1Gen
 ??. More...
 
class  UDP_Socket
 DP_Socket is a sub-class of channel. It is implemented with Berkeley datagram sockets using the UDP protocol. Messages delivery is thus unreliable. More...
 
class  UmfpackGenLinSOE
 UMFPACK (see SuiteSparse) based systems of equations. More...
 
class  UmfpackGenLinSolver
 UMFPACK based sparse matrix linear SOE solver. More...
 
class  UnbalAndTangent
 Vector de fuerza desequilibrada y tangent stiffness matrix. More...
 
class  UnbalAndTangentStorage
 Vector de fuerza desequilibrada y tangent stiffness matrix. More...
 
class  UniaxialFiber
 Representa una fibra de material uniaxial. More...
 
class  UniaxialFiber2d
 Uniaxial fiber on a bi-dimensional space. More...
 
class  UniaxialFiber3d
 Uniaxial fiber on a three-dimensional space. More...
 
class  UniaxialHistoryVars
 UniaxialHistoryVars stores values for strain and stiffness. More...
 
class  UniaxialMaterial
 Base class for uniaxial materials. More...
 
class  UniaxialMatPhysicalProperties
 Physical properties for shells. More...
 
class  UniaxialStateVars
 UniaxialStateVars stores values for material strain, stress and stiffness. More...
 
class  UniformExcitation
 Load pattern for a earthquake with a similar excitation for all supports. More...
 
class  UniformGrid
 Uniform mesh. Uniform node distributionn on x, y and z. More...
 
class  UniformRV
 
class  UpdatedLagrangianBeam2D
 Lagrangian 2D beam element. More...
 
class  UserDefinedBeamIntegration
 User defined integration over the beam. More...
 
class  UserDefinedBeamIntegrationBase
 Base class for user defined integration on beam elements. More...
 
class  UserDefinedHingeIntegration
 Base class for user defined integration on beam with hinges. More...
 
class  UserDefinedHingeIntegration2d
 User defined integration. More...
 
class  UserDefinedHingeIntegration3d
 3D hinge user defined integration. More...
 
class  UserDefinedHingeIntegrationBase
 Base class for hinge user defined integration. More...
 
class  UserDefinedRV
 
class  VariableTimeStepDirectIntegrationAnalysis
 perform a dynamic analysis on the FE_Model using a direct integration scheme. More...
 
class  VDependentFriction
 
class  Vector
 
class  VectorCells
 Cells vector. More...
 
class  VectorReinfBar
 Vector de barras de armadura. More...
 
class  VectorSeccionesBarraPrismatica
 Vector of pointers to SeccionBarraPrismaticaes. used to store the sections for each integration point. More...
 
class  Vertex
 Vertex of a graph. More...
 
class  VertexIter
 Iterator over the vertices of the graph. More...
 
class  ViscousMaterial
 Material de tipo viscoso. More...
 
class  VMPotentialSurface
 Von Mises potential surface. More...
 
class  VMYieldSurface
 Von Mises yield surface. More...
 
class  VPDependentFriction
 
class  WeibullRV
 
class  WEnergy
 ?? More...
 
class  WilsonTheta
 WilsonTheta is an algorithmic class for performing a transient analysis using the WilsonTheta integration scheme. More...
 
class  YieldSurface
 The goal is to create a platform for efficient and easy implemetation of any elasto-plastic constitutive model. More...
 
class  YieldSurface_BC
 Yield surface. More...
 
class  YieldSurface_BC2D
 BC 2D yield surface. More...
 
class  YieldSurfaceSection2d
 Base class for cross sections with yield surface on a bi-dimensional space (three DOFs for each section). More...
 
class  YS_Evolution
 Yield surface evolution. More...
 
class  YS_Evolution2D
 2D yield surface evolution. More...
 
class  YS_Section2D01
 Cross section with yield surface on a bi-dimensional problem (three DOFs for each section). More...
 
class  YS_Section2D02
 Cross section with yield surface fro bi-dimensional problem (three degrees of freedom in each section). More...
 
class  YsVisual
 
class  ZeroLength
 Zero length material. More...
 
class  ZeroLengthContact
 Zero length contact element. More...
 
class  ZeroLengthContact2D
 Zero length element for 2D contact problems. More...
 
class  ZeroLengthContact3D
 Zero lenght element for 3D problems. More...
 
class  ZeroLengthMaterials
 A ZeroLengthElement is defined by two nodes with the same coordinate. One or more material objects may be associated with the nodes to provide a force displacement relationship. ZeroLengthMaterials will work with 1d, 2d, or 3d material models. More...
 
class  ZeroLengthSection
 Zero length element with SectionForceDeformation material. More...
 

Typedefs

typedef std::map< std::string, LoadCombination * > LoadCombinationMap
 LoadCombinations.
 
typedef std::set< Node * > NodePtrSet
 
typedef std::list< Fiber * > contenedor_fibras
 Contenedor de fibras.
 
typedef struct XC::fileDatastoreOutputFile FileDatastoreOutputFile
 
typedef map< int, FileDatastoreOutputFile * > MAP_FILES
 
typedef MAP_FILES::value_type MAP_FILES_TYPE
 
typedef MAP_FILES::iterator MAP_FILES_ITERATOR
 
typedef struct XC::intData IntData
 
typedef struct XC::doubleData DoubleData
 

Enumerations

enum  InfoType {
  UnknownType, IntType, DoubleType, IdType,
  VectorType, MatrixType, TensorType
}
 
enum  DamageType {
  NotSpecified, Force, Deformation, PlasticDefo,
  TotalEnergy, PlasticEnergy
}
 
enum  ClaseEsfuerzo {
  TRACCION_SIMPLE, TRACCION_COMPUESTA, FLEXION_SIMPLE, FLEXION_COMPUESTA,
  COMPRESION_SIMPLE, COMPRESION_COMPUESTA, ERROR
}
 
enum  meshing_dir { dirm_i, dirm_j, dirm_k }
 
enum  openMode { OVERWRITE, APPEND }
 
enum  floatField { FIXEDD, SCIENTIFIC }
 

Functions

int sendDomain (Domain &, int posDbTag, DbTagData &, CommParameters &cp)
 Sends domain through the specified channel.
 
int receiveDomain (Domain &, int posDbTag, DbTagData &, CommParameters &cp)
 
std::ostream & operator<< (std::ostream &s, const PseudoTimeTracker &tt)
 
template<class T , class TIter >
T * getIterPtr (TIter &titer)
 
template<class ELEM_LOAD >
ELEM_LOAD * new_elem_load (LoadPattern *lp, int &tag_el)
 Adds a load over elements.
 
ElementalLoadprocesa_element_load (LoadPattern *, int &, const std::string &)
 Crea una nueva load over element.
 
int sendGroundMotionPtr (GroundMotion *, DbTagData &, CommParameters &cp, const BrokedPtrCommMetaData &)
 Envía a pointer al «ground motion» through the channel being passed as parameter. More...
 
GroundMotionreceiveGroundMotionPtr (GroundMotion *, DbTagData &, const CommParameters &cp, const BrokedPtrCommMetaData &)
 Recibe a pointer a «ground motion» through the channel being passed as parameter. More...
 
std::ostream & operator<< (std::ostream &os, const LoadCombination &)
 
int sendTimeSeriesPtr (TimeSeries *, int posClassTag, int posDbTag, DbTagData &, CommParameters &cp)
 Envía a pointer a la serie through the channel being passed as parameter. More...
 
TimeSeriesreceiveTimeSeriesPtr (TimeSeries *, int posClassTag, int posDbTag, DbTagData &, const CommParameters &cp)
 Recibe a pointer a la serie through the channel being passed as parameter. More...
 
double LovelyInnerProduct (const Vector &v, const Vector &w)
 Returns the inner product of the arguments.
 
double LovelyNorm (const Vector &v)
 Returns the vector norm.
 
Vector LovelyCrossProduct (const Vector &v, const Vector &w)
 Returns the cross product of the arguments.
 
Vector LovelyEig (const Matrix &M)
 compute eigenvalues and vectors for a 3 x 3 symmetric matrix More...
 
int sendEsfBeamColumn3d (const EsfBeamColumn3d &, int posDbTag, DbTagData &dt, CommParameters &cp)
 
int receiveEsfBeamColumn3d (EsfBeamColumn3d &v, int posDbTag, DbTagData &dt, const CommParameters &cp)
 
int sendBeamIntegrationPtr (BeamIntegration *, int posClassTag, int posDbTag, DbTagData &, CommParameters &)
 Envía a pointer a material through the channel being passed as parameter. More...
 
BeamIntegrationreceiveBeamIntegrationPtr (BeamIntegration *, int posClassTag, int posDbTag, DbTagData &, const CommParameters &)
 Recibe a pointer a material through the channel being passed as parameter. More...
 
double invert2by2Matrix (const Matrix &a, Matrix &b)
 
double invert3by3Matrix (const Matrix &a, Matrix &b)
 
void invertMatrix (int n, const Matrix &a, Matrix &b)
 
void getCBDIinfluenceMatrix (int nIntegrPts, const Matrix &xi_pt, double L, Matrix &ls)
 
void getCBDIinfluenceMatrix (int nIntegrPts, double *pts, double L, Matrix &ls)
 
std::ostream & operator<< (std::ostream &os, const BodyForces &bf)
 
std::ostream & operator<< (std::ostream &, const FVector &f)
 
const GaussModel gauss_model_tria1 (Pos2d(0, 0), Pos2d(1, 0), Pos2d(0, 1), GaussPoint(Pos2d(0.333333333333333, 0.333333333333333), 0.5))
 
const GaussModel gauss_model_tria3 (Pos2d(0, 0), Pos2d(1, 0), Pos2d(0, 1), GaussPoint(Pos2d(0.2, 0.2), 0.3334), GaussPoint(Pos2d(0.8, 0.1), 0.3334), GaussPoint(Pos2d(0.1, 0.8), 0.3334))
 
const GaussModel gauss_model_quad4 (Pos2d(-1,-1), Pos2d(1,-1), Pos2d(1, 1), Pos2d(-1, 1), GaussPoint(Pos2d(-one_over_root3,-one_over_root3), 1), GaussPoint(Pos2d(one_over_root3,-one_over_root3), 1), GaussPoint(Pos2d(one_over_root3, one_over_root3), 1), GaussPoint(Pos2d(-one_over_root3, one_over_root3), 1))
 
const GaussModel gauss_model_quad9 (Pos2d(-1,-1), Pos2d(0,-1), Pos2d(1,-1), Pos2d(1, 0), Pos2d(1, 1), Pos2d(0, 1), Pos2d(-1, 1), Pos2d(-1, 0), Pos2d(0, 0), GaussPoint(Pos2d(-root3_over_root5,-root3_over_root5), 25.0/81.0), GaussPoint(Pos2d(0,-root3_over_root5), 40.0/81.0), GaussPoint(Pos2d(root3_over_root5,-root3_over_root5), 25.0/81.0), GaussPoint(Pos2d(root3_over_root5, 0), 40.0/81.0), GaussPoint(Pos2d(root3_over_root5, root3_over_root5), 25.0/81.0), GaussPoint(Pos2d(0, root3_over_root5), 40.0/81.0), GaussPoint(Pos2d(-root3_over_root5, root3_over_root5), 25.0/81.0), GaussPoint(Pos2d(-root3_over_root5, 0), 40.0/81.0), GaussPoint(Pos2d(0, 0), 64.0/81.0))
 
bool operator== (const ElemPos &A, const ElemPos &B)
 
std::ostream & operator<< (std::ostream &os, const NodePtrsWithIDs &nodePtrs)
 
std::ostream & operator<< (std::ostream &, const ParticlePos3d &)
 
std::ostream & operator<< (std::ostream &os, const RayleighDampingFactors &rF)
 
void shp3d (const double ss[3], double &xsj, double shp[4][8], const double xl[3][8])
 
int brcshl (double shl[4][20][27], double w[27], int nint, int nen)
 
std::ostream & operator<< (std::ostream &os, const MeshEdge &me)
 
std::deque< Polilinea3d > getContours (MeshEdges edges, bool undeformedGeometry)
 returns closed contours from de edge set.
 
std::ostream & operator<< (std::ostream &os, const MeshEdges &me)
 
bool operator== (const NodePos &A, const NodePos &B)
 
Pos3d pos_node (const Node &nod, bool initialGeometry=true)
 Return the 3D position of the node. More...
 
std::set< Element * > getElementsBetweenNodes (Node &, Node &)
 Returns the elements that are connected to both nodes.
 
std::set< Element * > getConnectedElements (const NodePtrSet &)
 Returns the elements connected to any of the set nodes.
 
ElementEdges getElementEdgesEntreNodos (Node *, Node *)
 Returns the element edges that have both nodes as ends.
 
ElementEdges getElementEdgesEntreNodos (const NodePtrSet &)
 Returns the element edges with both end nodes included in the container being passed as parameter.
 
bool in (const NodePtrSet &, const std::vector< const Node * > &)
 Returns true if the node pointers in nodes_edget are in the set being passed as parameter.
 
int sendMaterialPtr (Material *, DbTagData &, CommParameters &cp, const BrokedPtrCommMetaData &)
 Sends a pointer to material through the communicator being passed as parameter. More...
 
MaterialreceiveMaterialPtr (Material *, DbTagData &, const CommParameters &cp, const BrokedPtrCommMetaData &)
 Receives a pointer to material through the communicator being passed as parameter. More...
 
NDMaterialreceiveNDMaterialPtr (NDMaterial *, DbTagData &, const CommParameters &, const BrokedPtrCommMetaData &)
 Recibe a pointer a material through the channel being passed as parameter.
 
double operator&& (const Vector &, const Vector &)
 
std::ostream & operator<< (std::ostream &os, const CAMPotentialSurface &YS)
 
std::ostream & operator<< (std::ostream &os, const CAMYieldSurface &YS)
 
std::ostream & operator<< (std::ostream &os, const DPPotentialSurface &PS)
 
std::ostream & operator<< (std::ostream &os, const DPYieldSurface01 &YS)
 
std::ostream & operator<< (std::ostream &os, const EvolutionLaw_S &EL)
 
double g_0 (double, double)
 
double g_prime (double, double)
 
double g_second (double, double)
 
std::ostream & operator<< (std::ostream &os, const BaseElasticSection3d &scc)
 
FiberSection2d FiberSectionReprToFiberSection2d (const int &tag, const FiberSectionRepr &fiberSectionRepr)
 
FiberSection3d FiberSectionReprToFiberSection3d (const int &tag, const FiberSectionRepr &fiberSectionRepr)
 
FiberSectionGJ FiberSectionReprToFiberSectionGJ (const int &tag, const FiberSectionRepr &fiberSectionRepr, const double &GJ)
 
InteractionDiagram calc_interaction_diagram (const FiberSectionBase &, const InteractionDiagramData &)
 
InteractionDiagram2d calcPlaneInteractionDiagram (const FiberSectionBase &scc, const InteractionDiagramData &, const double &)
 
InteractionDiagram2d calcNMyInteractionDiagram (const FiberSectionBase &scc, const InteractionDiagramData &)
 
InteractionDiagram2d calcNMzInteractionDiagram (const FiberSectionBase &scc, const InteractionDiagramData &)
 
std::ostream & operator<< (std::ostream &os, const Pivots &p)
 
std::ostream & operator<< (std::ostream &s, const Cell &cell)
 
std::ostream & operator<< (std::ostream &os, const CrossSectionProperties2d &c)
 
std::set< const Eje * > GetLineasTocan (const Spot &p)
 Returns the set of lines that touch the point being passed as parameter.
 
std::ostream & operator<< (std::ostream &os, const ListRegiones &lr)
 
std::ostream & operator<< (std::ostream &s, const ReinfLayer &)
 
std::ostream & operator<< (std::ostream &os, const Conc02HistoryVars &hv)
 
UniaxialMaterialreceiveUniaxialMaterialPtr (UniaxialMaterial *, DbTagData &, const CommParameters &, const BrokedPtrCommMetaData &)
 Recibe a pointer a material through the channel being passed as parameter.
 
TritrizPtrElem put_quad4N_on_mesh (const Element &e, const TritrizPtrNod &, meshing_dir dm)
 Place the elements on the mesh passed as parameter.
 
TritrizPtrElem put_quad9N_on_mesh (const Element &e, const TritrizPtrNod &, meshing_dir dm)
 Places the elements on the mesh passed as parameter.
 
std::set< const Body * > GetCuerposTocan (const Face &s)
 Return the bodies that touch the surface passed as parameter (neighbors).
 
bool operator== (const CmbEdge::Lado &il1, const CmbEdge::Lado &il2)
 Operador de igualdad.
 
std::set< const Edge * > GetLineasTocan (const Pnt &p)
 Return the list of edges that have this point as starting or ending point.
 
size_t calcula_ndiv_lados (const std::set< const XC::Edge * > &)
 Compute the number of divisions for each line to make it compatible with adjacent surface meshing.
 
std::set< const Face * > GetSupsTocan (const Edge &l)
 Return the surfaces that touch the line.
 
Vectoroperator- (const Pnt &b, const Pnt &a)
 
const Edgebusca_edge_const_ptr_toca (const Pnt &, const Pnt &)
 Search for a line that connects the points.
 
const Edgebusca_edge_const_ptr_toca (const Pnt &, const Pnt &, const Pnt &)
 Search for a line that connects the points.
 
Edgebusca_edge_ptr_toca (const Pnt &, const Pnt &)
 Search for a line that connects the points.
 
Edgebusca_edge_ptr_toca (const Pnt &, const Pnt &, const Pnt &)
 Search for a line that connects the points.
 
Edgebusca_edge_ptr_extremos (const Pnt &pA, const Pnt &pB)
 Search for a line that connects the points.
 
Edgebusca_edge_ptr_extremos (const Pnt &, const Pnt &, const Pnt &)
 Search for a line that connects the points.
 
const Edgebusca_edge_const_ptr_extremos (const Pnt &pA, const Pnt &pB)
 Search for a line that connects the points.
 
const Edgebusca_edge_const_ptr_extremos (const Pnt &, const Pnt &, const Pnt &)
 Search for a line that connects the points.
 
std::ostream & operator<< (std::ostream &os, const TritrizPtrNod &)
 
void fix (const TritrizPtrNod &ttz, const SFreedom_Constraint &spc)
 
void fix (const TritrizPtrNod::var_ref_caja &ref_caja, const SFreedom_Constraint &spc)
 
std::vector< int > getIdNodosQuad4N (const TritrizPtrNod::const_ref_capa_i_cte &nodos, const size_t &j, const size_t &k)
 Returns the indexes of the nodes (j,k),(j+1,k),(j+1,k+1),(j,k+1).
 
std::vector< int > getIdNodosQuad9N (const TritrizPtrNod::const_ref_capa_i_cte &nodos, const size_t &j, const size_t &k)
 Returns the indexes of the nodes (j,k),(j+1,k),(j+1,k+1),(j,k+1).
 
std::ostream & operator<< (std::ostream &os, const TritrizPtrPnt &)
 
std::vector< size_t > getIdPuntosQuad (const TritrizPtrPnt::const_ref_capa_i_cte &, const size_t &j, const size_t &k)
 Returns the indexes of the points (j,k),(j+1,k),(j+1,k+1),(j,k+1).
 
template<typename ELEM >
ELEM * new_element (int tag_elem)
 
template<typename ELEM >
ELEM * new_element_gen_mat (int tag_elem, Material *ptrMat)
 Creates a new element and assigns it a material.
 
template<typename ELEM >
ELEM * new_element_dim_gen_mat (int tag_elem, int dime, Material *ptrMat)
 Creates a new element and assigns it a material.
 
template<typename ELEM >
ELEM * new_element_dim_gen_mat_dir (int tag_elem, int dime, Material *ptrMat, int d)
 
template<typename ELEM >
ELEM * new_element_gen_mat_crd (int tag_elem, Material *ptrMat, CrdTransf *ptrTrf)
 
template<typename ELEM >
ELEM * new_element_dim_gen_mat_crd (int tag_elem, int dime, Material *ptrMat, CrdTransf *ptrTrf)
 
template<typename ELEM >
ELEM * new_element_ns_gen_mat_crd (int tag_elem, Material *ptrMat, int ns, CrdTransf *ptrTrf)
 
template<typename ELEM >
ELEM * new_element_ns_gen_mat_crd_integ (int tag_elem, Material *ptrMat, int ns, CrdTransf *ptrTrf, BeamIntegration *ptrInteg)
 
template<typename ELEM , typename MAT >
ELEM * new_element_mat (int tag_elem, Material *ptrMat)
 
template<typename ELEM >
ELEM * new_element_mat_crd (int tag_elem, Material *ptrMat, CrdTransf *ptrTrf)
 
meshing_dir str_to_meshing_dir (const std::string &)
 Return mesh direction from the string being passed as parameter (i, j or k).
 
std::string getXCVersion (void)
 
std::string getXCVersionShort (void)
 
int symFactorization (int *fxadj, int *adjncy, int neq, int LSPARSE, int **xblkMY, int **invpMY, int **rowblksMY, OFFDBLK ***begblkMY, OFFDBLK **firstMY, double ***penvMY, double **diagMY)
 
std::ostream & operator<< (std::ostream &os, const DbTagData &)
 
template<class T >
int sendMap (const std::map< std::string, T * > &m, CommParameters &cp, DbTagData &dt, const CommMetaData &meta)
 
template<class T >
int receiveMap (std::map< std::string, T * > &v, const CommParameters &cp, DbTagData &dt, const CommMetaData &meta, T *(FEM_ObjectBroker::*ptrFunc)(int))
 
template<class T >
T * getBrokedMovable (const int &dbTag, const int &classTag, const CommParameters &cp, T *(FEM_ObjectBroker::*ptrFunc)(int))
 
ID getIDFromIntPtr (const int *, const int &)
 
std::ostream & operator<< (std::ostream &, const ID &)
 A function is defined to allow user to print the IDs using streams.
 
std::ostream & operator<< (std::ostream &, const IntPtrWrapper &)
 A function is defined to allow user to print the IntPtrWrappers using streams.
 
std::vector< int > id_to_std_vector (const IntPtrWrapper &)
 Convierte el vector en un std::vector<double>.
 
Matrix m_double_to_matrix (const m_double &m)
 Convierte una matriz de tipo m_double otra de tipo Matrix.
 
m_double matrix_to_m_double (const Matrix &m)
 Convierte a una matriz de tipo m_double.
 
Matrix identity (const Matrix &m)
 
Matrix transposed (const Matrix &m)
 
BJtensor operator* (const double &lval, const BJtensor &rval)
 
std::ostream & operator<< (std::ostream &os, const Cosseratstresstensor &rhs)
 
nDarray operator* (const double lval, const nDarray &rval)
 
std::ostream & operator<< (std::ostream &os, const straintensor &rhs)
 
std::ostream & operator<< (std::ostream &os, const stresstensor &rhs)
 
m_double Vector_to_m_double (const Vector &)
 
std::vector< double > vector_to_std_vector (const Vector &)
 Convierte el vector en un std::vector<double>.
 
m_double vector_to_m_double (const Vector &)
 Convierte el vector en un m_double.
 
double dot (const Vector &a, const Vector &b)
 
Matrix prod_tensor (const Vector &, const Vector &)
 Producto tensorial de dos tensores de primer orden. More...
 
Matrix operator& (const Vector &u, const Vector &v)
 tensor product.
 
Vector normalize (const Vector &)
 Returns the normalized vector (euclidean norm).
 
Vector normalize_inf (const Vector &)
 Returns the normalized vector (infinite norm).
 
std::ostream & operator<< (std::ostream &, const MEDMapIndices &)
 
int getLibraryFunction (const char *libName, const char *functName, void **libHandle, void **funcHandle)
 
std::ostream & operator<< (std::ostream &s, const Timer &E)
 
boost::python::list xc_id_to_py_list (const XC::ID &)
 
std::vector< double > vector_double_from_py_object (const boost::python::object &)
 
std::vector< int > vector_int_from_py_object (const boost::python::object &)
 
m_double m_double_from_py_object (const boost::python::object &)
 

Variables

const GaussModel gauss_model_empty
 
const double root3 = sqrt(3.0)
 
const double one_over_root3 = 1.0/root3
 
const double root5 = sqrt(5.0)
 
const double root3_over_root5 = root3/root5
 
XC::Vector Info (109+3)
 
XC::Vector InfoPt (FixedOrder *FixedOrder *FixedOrder *4+1)
 
XC::Vector InfoSt (FixedOrder *FixedOrder *FixedOrder *6+1)
 
XC::Vector Gsc (FixedOrder *FixedOrder *FixedOrder *3+1)
 
XC::Vector InfoSpq2 (2)
 
XC::Vector InfoMoment (109+3)
 
XC::Vector InfoPlastic (FixedOrder *FixedOrder *FixedOrder *4+1)
 
XC::Vector InfoStress (FixedOrder *FixedOrder *FixedOrder *6+1)
 
XC::Vector GaussCoord (FixedOrder *FixedOrder *FixedOrder *3+1)
 
XC::Vector Info_pq2 (2)
 
const std::string strTipo3D = "3D"
 
const std::string strTipoAxiSymmetric = "AxiSymmetric"
 
const std::string strTipoAxiSymmetric2D = "AxiSymmetric2D"
 
const std::string strTipoBeamFiber = "BeamFiber"
 
const std::string strTipoElasticIsotropic3D = "ElasticIsotropic3D"
 
const std::string strTipoFDEP3D = "FDEP3D"
 
const std::string strTipoFiniteDeformationEP3D = "FiniteDeformationEP3D"
 
const std::string strTipoFluidSolidPorous = "FluidSolidPorous"
 
const std::string strTipoPlaneStress2D = "PlaneStress2D"
 
const std::string strTipoPlaneStress = "PlaneStress"
 
const std::string strTipoPlaneStrain2D = "PlaneStrain2D"
 
const std::string strTipoPlaneStrain = "PlaneStrain"
 
const std::string strTipoPlateFiber = "PlateFiber"
 
const std::string strTipoPressureIndependMultiYield = "PressureIndependMultiYield"
 
const std::string strTipoPressureIndependMultiYield02 = "PressureIndependMultiiYield02"
 
const std::string strTipoTemplate3Dep = "Template3Dep"
 
const std::string strTipoThreeDimensional = "ThreeDimensional"
 
const std::string strTipoThreeDimensionalFD = "ThreeDimensionalFD"
 
const std::string strTipoError = "error"
 
const int SECTION_RESPONSE_MZ = 1
 
const int SECTION_RESPONSE_P = 2
 
const int SECTION_RESPONSE_VY = 3
 
const int SECTION_RESPONSE_MY = 4
 
const int SECTION_RESPONSE_VZ = 5
 
const int SECTION_RESPONSE_T = 6
 
const int MEMBRANE_RESPONSE_n1 = 11
 
const int MEMBRANE_RESPONSE_n2 = 12
 
const int MEMBRANE_RESPONSE_n12 = 13
 
const int PLATE_RESPONSE_m1 = 14
 
const int PLATE_RESPONSE_m2 = 15
 
const int PLATE_RESPONSE_m12 = 16
 
const int PLATE_RESPONSE_q13 = 17
 
const int PLATE_RESPONSE_q23 = 18
 
const RespPMz RespElasticSection2d
 
const RespPMzV RespElasticShSection2d
 
const RespVyP RespBidirectional
 
const RespPMzMy RespFiberSection3d
 
const RespPMzMyT RespElasticSection3d
 
const RespPMzVyMyVzT RespElasticShSection3d
 
const RespFiberSectionShear3d RespFiberSectionSh3d
 
const RespPVyMz RespIsolator2spring
 
const RespMembraneMaterial RespMembraneMat
 
const RespPlateMaterial RespPlateMat
 
const RespShellMaterial RespShellMat
 
const double STEEL_0103_DEFAULT_A1 = 0.0
 
const double STEEL_0103_DEFAULT_A2 = 55.0
 
const double STEEL_0103_DEFAULT_A3 = 0.0
 
const double STEEL_0103_DEFAULT_A4 = 55.0
 
const double DefaultPenaltyFactor = 1e7
 
const std::string gVERSION = "v0.12-563-gd35802b-d"
 
const std::string gVERSION_SHORT = "0.12.v0.12-563-gd35802b-d"
 

Detailed Description

================================================================================

Open source finite element program for structural analysis.

Therefore, this is a pseudo PeakOriented model, for true PeakOriented, use PeakOriented01

isotropic:kinematic ratio = 0.5:0.5

Author
rkaul
rkaul

Function Documentation

XC::Vector XC::LovelyEig ( const Matrix M)

compute eigenvalues and vectors for a 3 x 3 symmetric matrix

.... INPUTS: M(3,3) - matrix with initial values (only upper half used)

.... OUTPUTS v(3,3) - matrix of eigenvectors (by column) d(3) - eigenvalues associated with columns of v rot - number of rotations to diagonalize

---------------------------------------------------------——eig3== .... Storage done as follows:

   | v(1,1) v(1,2) v(1,3) |     |  d(1)  a(1)  a(3)  |
   | v(2,1) v(2,2) v(2,3) |  =  |  a(1)  d(2)  a(2)  |
   | v(3,1) v(3,2) v(3,3) |     |  a(3)  a(2)  d(3)  |

   Transformations performed on d(i) and a(i) and v(i,j) become
    the eigenvectors.  

------------------------------------------------------------—eig3==

Pos3d XC::pos_node ( const Node nod,
bool  initialGeometry = true 
)

Return the 3D position of the node.

Parameters
initialGeometryif true initial position of the node is considered.
XC::Matrix XC::prod_tensor ( const Vector u,
const Vector v 
)

Producto tensorial de dos tensores de primer orden.

Parameters
uvector fila.
vvector columna.
XC::BeamIntegration * XC::receiveBeamIntegrationPtr ( BeamIntegration ptr,
int  posClassTag,
int  posDbTag,
DbTagData dt,
const CommParameters cp 
)

Recibe a pointer a material through the channel being passed as parameter.

Parameters
posClassTagindex of the class tags in the data vector
posDbTagindex of the dbTag in the data vector
XC::GroundMotion * XC::receiveGroundMotionPtr ( GroundMotion ptr,
DbTagData dt,
const CommParameters cp,
const BrokedPtrCommMetaData md 
)

Recibe a pointer a «ground motion» through the channel being passed as parameter.

Parameters
posClassTagIndex for the class identifier of the object (in ID).
posDbTagIndex for the dbTag of the object (in ID).
XC::Material * XC::receiveMaterialPtr ( Material ptr,
DbTagData dt,
const CommParameters cp,
const BrokedPtrCommMetaData md 
)

Receives a pointer to material through the communicator being passed as parameter.

Parameters
posClassTagIndex of the material class identifier.
posDbTagIndex of the dbTag.
XC::TimeSeries * XC::receiveTimeSeriesPtr ( TimeSeries ptr,
int  posClassTag,
int  posDbTag,
DbTagData dt,
const CommParameters cp 
)

Recibe a pointer a la serie through the channel being passed as parameter.

Parameters
posClassTagindex of class identifier in the data vector.
posDbTagindex of the dbTag in the data vector
int XC::sendBeamIntegrationPtr ( BeamIntegration ptr,
int  posClassTag,
int  posDbTag,
DbTagData dt,
CommParameters cp 
)

Envía a pointer a material through the channel being passed as parameter.

Parameters
posClassTagindex of the class tags in the data vector
posDbTagindex of the dbTag in the data vector
int XC::sendGroundMotionPtr ( GroundMotion ptr,
DbTagData dt,
CommParameters cp,
const BrokedPtrCommMetaData md 
)

Envía a pointer al «ground motion» through the channel being passed as parameter.

Parameters
posClassTagIndex for the class identifier of the object (in ID).
posDbTagIndex for the dbTag of the object (in ID).
int XC::sendMaterialPtr ( Material ptr,
DbTagData dt,
CommParameters cp,
const BrokedPtrCommMetaData md 
)

Sends a pointer to material through the communicator being passed as parameter.

Parameters
posClassTagIndex of the material class identifier.
posDbTagIndex of the dbTag.
int XC::sendTimeSeriesPtr ( TimeSeries ptr,
int  posClassTag,
int  posDbTag,
DbTagData dt,
CommParameters cp 
)

Envía a pointer a la serie through the channel being passed as parameter.

Parameters
posClassTagindex of the class tag in the data vector.
posDbTagindex of the dbTag in the data vector