KratosMultiphysics
KRATOS Multiphysics (Kratos) is a framework for building parallel, multi-disciplinary simulation software, aiming at modularity, extensibility, and high performance. Kratos is written in C++, and counts with an extensive Python interface.
Namespaces | Classes | Typedefs | Enumerations | Functions | Variables
Kratos Namespace Reference

REF: G. R. Cowper, GAUSSIAN QUADRATURE FORMULAS FOR TRIANGLES. More...

Namespaces

 ActiveSetUtilities
 
 AuxiliaryFunctions
 
 AuxiliaryOperationsUtilities
 
 BinaryOperations
 
 CompressibleNavierStokesExplicitInternal
 
 ConstraintUtilities
 
 ContainerDataIOTags
 
 ContainerExpressionHelperUtilities
 
 ContainerVariableDataHolderUtilsHelper
 
 ConvectionDiffusionReactionStabilizationUtilities
 
 CppTestsUtilities
 
 DataCommunicatorFactory
 Common tools to define new MPI DataCommunicators.
 
 DelaunatorUtilities
 
 DemDebugFunctions
 
 Detail
 
 EmbeddedDiscontinuousInternals
 
 EmbeddedLaplacianInternals
 
 EntitiesUtilities
 
 ExplicitFilterHelperUtilities
 
 ExplicitIntegrationUtilities
 
 ExpressionHelperUtilities
 
 filesystem
 
 FluidAdjointElementHelperUtilities
 
 FluidAdjointTestUtilitiesHelper
 
 FluxConditionInternals
 
 GeometricalTransformationUtilities
 
 GeometryFunctions
 
 Globals
 
 HDF5
 
 IntegrationPointExpressionIOUtils
 
 Internals
 
 KEpsilonElementData
 
 KEpsilonWallConditionData
 
 KOmegaElementData
 
 KOmegaSSTElementData
 
 KOmegaWallConditionData
 
 LineOutputProcessUtilities
 
 MapperDefinitions
 
 MapperUtilities
 
 MappingIntersectionUtilities
 
 MeshingUtilities
 
 MeshVelocityCalculation
 
 MethodUtilities
 
 MicroClimateConstants
 
 ModelerFactory
 Creates Modelers.
 
 ModelPartHelperUtils
 
 MortarUtilities
 
 MoveMeshUtilities
 
 MPIInternals
 
 MPIMapperDefinitions
 
 MPMEnergyCalculationUtility
 
 MPMExplicitUtilities
 
 MPMParticleGeneratorUtility
 
 MPMSearchElementUtility
 
 NodalInterpolationFunctions
 
 NurbsUtilities
 Utility functions for NURBS computation.
 
 PolynomialUtilities
 
 PotentialFlowUtilities
 
 ProjectionUtilities
 
 PropertiesUtilities
 
 Python
 
 QSVMSDerivativeHelperUtilities
 
 RansApplicationTestUtilities
 
 RansCalculationUtilities
 
 RansVariableUtilities
 
 RayleighDampingCoefficientsUtilities
 
 SearchUtils
 SEARCH UTILS ////.
 
 SelfContactUtilities
 
 ShellUtilities
 
 SpatialMethods
 
 StaticCondensationUtility
 
 StressResponseDefinitions
 
 StringUtilities
 
 StructuralMechanicsElementUtilities
 
 TemporalMethods
 
 TemporalMethodUtilities
 
 Testing
 
 TimeDiscretization
 
 TrilinosSolverUtilities
 
 UnaryStatisticOperations
 
 Utilities
 
 VariableExpressionDataIOHelperUtilities
 
 VtuOutputHelperUtilities
 
 WallDistanceCalculationUtilities
 
 Wind
 
 XmlOStreamAsciiWriterHelperUtilities
 
 XmlOStreamBase64BinaryWriterHelperUtilities
 

Classes

class  MeshCondition
 This is pure geometric condition. The only purpose for this definition is to create dummy conditions. More...
 
class  LinearMasterSlaveConstraint
 This class allows to add a master-slave constraint which is of the form SlaveDofVector = T * MasterDofVector + ConstantVector. More...
 
class  SlipConstraint
 This constructs a constraint which imposes that v * n = 0 where: v is a variable n is the unit normal to the node. More...
 
class  array_1d
 Short class definition. More...
 
class  CsrMatrix
 This class implements "serial" CSR matrix, including capabilities for FEM assembly. More...
 
class  DataValueContainer
 Container for storing data values associated with variables. More...
 
class  DistributedCsrMatrix
 This class implements "serial" CSR matrix, including capabilities for FEM assembly. More...
 
class  DistributedNumbering
 This function provides essential capabilities for mapping between local and global ids in a distributed vector. More...
 
class  DistributedSparseGraph
 Short class definition. More...
 
class  DistributedSystemVector
 Provides a DistributedSystemVector which implements FEM assemble capabilities. More...
 
class  DistributedVectorExporter
 Provides a DistributedVectorExporter which implements FEM assemble capabilities. More...
 
class  DistributedVectorImporter
 Provides a DistributedVectorImporter which implements FEM assemble capabilities. More...
 
class  EdgeBasedDataStructure
 
class  Flags
 
class  GeometryContainer
 
class  GlobalPointersUnorderedMap
 Short class definition. More...
 
class  GlobalPointersVector
 This class is a vector which stores global pointers. More...
 
class  Model
 This class aims to manage different model parts across multi-physics simulations. More...
 
class  NodalData
 Stores all data and dofs which are stored in each elements. More...
 
class  partitioned_vector
 Short class definition. More...
 
class  PeriodicVariablesContainer
 A container of Kratos variables used to define a periodic boundary condition. More...
 
class  PointerHashMapSet
 PointerHashMapSet is a hash implemenetation of the PointerVectorSet. More...
 
class  PointerVector
 PointerVector is a container like stl vector but using a vector to store pointers to its data. More...
 
class  PointerVectorMap
 PointerVectorMap is a sorted associative container like stl map but using a vector to store pointers to its data. More...
 
class  PointerVectorMapIterator
 Short class definition. More...
 
class  PointerVectorSet
 A sorted associative container similar to an STL set, but uses a vector to store pointers to its data. More...
 
class  SetIdentityFunction
 A functor that serves as the identity function. More...
 
class  SparseContiguousRowGraph
 Short class definition. More...
 
class  SparseGraph
 Short class definition. More...
 
class  SystemVector
 Provides a SystemVector which implements FEM assemble capabilities, as well as some vector operations. More...
 
class  Variable
 Variable class contains all information needed to store and retrive data from a data container. More...
 
class  VariableData
 This class is the base of variables and variable's components which contains their common data. More...
 
class  VariablesList
 Holds a list of variables and their position in VariablesListDataValueContainer. More...
 
class  VariablesListDataValueContainer
 A shared variable list gives the position of each variable in the containers sharing it. More...
 
class  WeakPointerVector
 WeakPointerVector is a container like stl vector but using a vector to store pointers to its data. More...
 
class  WeakPointerVectorIterator
 Short class definition. More...
 
class  Controller
 The base class for all Controllers in Kratos. More...
 
class  OutputController
 
class  DistanceCalculationElementSimplex
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  EdgeBasedGradientRecoveryElement
 An element to compute the a nodal variable from an embedded skin. More...
 
class  EmbeddedNodalVariableCalculationElementSimplex
 An element to compute the a nodal variable from an embedded skin. More...
 
class  LevelSetConvectionElementSimplex
 formulation described in https://docs.google.com/document/d/13a_zGLj6xORDuLgoOG5LwHI6BwShvfO166opZ815zLY/edit?usp=sharing More...
 
class  LevelSetConvectionElementSimplexAlgebraicStabilization
 
class  MeshElement
 This is pure geometric element. The only purpose for this definition is to create dummy elements. More...
 
class  BinaryExpression
 
class  CArrayExpressionIO
 
struct  ContainerDataIO
 
struct  ContainerDataIO< ContainerDataIOTags::Historical >
 
struct  ContainerDataIO< ContainerDataIOTags::NonHistorical >
 
class  ContainerExpression
 Container variable data holder. More...
 
class  DomainSizeExpressionIO
 Utility class for domain size IO. More...
 
class  Expression
 Base class or all the expression types. More...
 
class  ExpressionInput
 
class  ExpressionOutput
 
class  ExpressionIOUtils
 
class  ExpressionUtils
 
class  IntegrationPointExpressionIO
 
class  LiteralExpression
 Expression to hold a literal value. More...
 
class  LiteralExpressionIO
 
class  LiteralFlatExpression
 Expression to hold a literal with a flattened data structure. More...
 
class  LiteralScalarFlatExpression
 
class  LiteralNonScalarFlatExpression
 
class  NodalPositionExpressionIO
 
class  UnaryAbsExpression
 Unary abs expression used to get the absolute values of a given input expression. More...
 
class  UnaryCombineExpression
 Use to create an expression which combines given input expressions list in the order given. More...
 
class  UnaryReshapeExpression
 Used to create lazy expression to reshape given expression to a new shape. More...
 
class  UnarySliceExpression
 Unary slice expression used to represent a slicing lazy expression of a given input expression. More...
 
class  UnaryStatisticsExpression
 Used to create lazy expression to get statistical quantities of entity values. More...
 
class  VariableExpressionDataIO
 Construct class to read into expressions from templated data values and write in to templated data values. More...
 
class  VariableExpressionIO
 
class  FactoryBase
 Here we define some common methods. More...
 
class  Factory
 Here we add the functions needed for the registration of class. More...
 
class  LinearSolverFactory
 Here we add the functions needed for the registration of linear solvers. More...
 
class  MapperFactory
 Python Interface of the MappingApplication. More...
 
class  PreconditionerFactory
 Here we add the functions needed for the registration of preconditioners. More...
 
class  StandardLinearSolverFactory
 Here we add the functions needed for the registration of linear solvers. More...
 
class  StandardPreconditionerFactory
 Here we add the functions needed for the registration of preconditioners. More...
 
class  BoundingBox
 Representing a bounding box by storing the min and max points. More...
 
class  BrepCurve
 The BrepCurve acts as topology for curves. Those can be enclosed by a certain set of points. More...
 
class  BrepCurveOnSurface
 The BrepCurveOnSurface acts as topology for curves on surfaces. More...
 
class  BrepSurface
 The BrepSurface acts as topology for faces. Those can be enclosed by a certain set of brep face curves. More...
 
class  CouplingGeometry
 The CouplingGeometry connects two or more geometries of different types and entities. More...
 
class  Geometry
 Geometry base class. More...
 
class  GeometryData
 
class  GeometryDimension
 
class  GeometryShapeFunctionContainer
 
class  Hexahedra3D20
 A twenty node hexahedra geometry with serendipity shape functions. More...
 
class  Hexahedra3D27
 A twenty-seven node hexahedra geometry with second order shape functions. More...
 
class  Hexahedra3D8
 An eight node hexahedra geometry with linear shape functions. More...
 
class  HexahedraInterface3D8
 
class  Line2D2
 An two node 2D line geometry with linear shape functions. More...
 
class  Line2D3
 An three node 2D line geometry with quadratic shape functions. More...
 
class  Line2D4
 An three node 2D line geometry with cubic shape functions. More...
 
class  Line2D5
 An five node 2D line geometry with quartic shape functions. More...
 
class  Line3D2
 An two node 3D line geometry with linear shape functions. More...
 
class  Line3D3
 An three node 3D line geometry with quadratic shape functions. More...
 
class  LineGaussLobatto3D2
 
class  NurbsCurveGeometry
 
class  NurbsCurveOnSurfaceGeometry
 
class  NurbsCurveShapeFunction
 NurbsCurveShapeFunction. More...
 
class  NurbsInterval
 Class for optimized use of intervals. More...
 
class  NurbsSurfaceRefinementUtilities
 
class  NurbsSurfaceShapeFunction
 
class  NurbsVolumeRefinementUtilities
 
class  NurbsVolumeShapeFunction
 
class  NurbsSurfaceGeometry
 
class  NurbsVolumeGeometry
 A volume geometry based on a full 3-dimensional BSpline tensor product. More...
 
class  OrientedBoundingBox
 This class defines the Oriented bounding box class. More...
 
class  Plane
 
class  Plane3D
 
class  Point
 Point class. More...
 
class  Point2D
 
class  Point3D
 
class  PointOnGeometry
 
class  Prism3D15
 A fifteen node prism geometry with quadratic shape functions. More...
 
class  Prism3D6
 A six node prism geometry with linear shape functions. More...
 
class  PrismInterface3D6
 
class  Pyramid3D13
 A 13 node pyramid geometry with quadratic shape functions. More...
 
class  Pyramid3D5
 A five node pyramid geometry with linear shape functions. More...
 
class  QuadraturePointCurveOnSurfaceGeometry
 
class  QuadraturePointGeometry
 A sinlge quadrature point, that can be used for geometries without a predefined integration scheme, i.e. they can handle material point elements, isogeometric analysis elements or standard finite elements which are defined at a single quadrature point. This point defines a line segment described on a underlying surface. Shape functions and integration types have to be precomputed and are set from from outside. The parent pointer can provide the adress to the owner of this quadrature point. More...
 
class  QuadraturePointSurfaceInVolumeGeometry
 A sinlge quadrature point, that can be used for geometries without a predefined integration scheme, i.e. they can handle material point elements, isogeometric analysis elements or standard finite elements which are defined at a single quadrature point. This point defines a surface segment described in a underlying volume. Shape functions and integration types have to be precomputed and are set from outside. The parent pointer can provide the adress to the owner of this quadrature point. More...
 
class  Quadrilateral2D4
 A four node 2D quadrilateral geometry with bi-linear shape functions. More...
 
class  Quadrilateral2D8
 A eight node 2D quadrilateral geometry with quadratic shape functions. More...
 
class  Quadrilateral2D9
 A nine node 2D quadrilateral geometry with quadratic shape functions. More...
 
class  Quadrilateral3D4
 A four node 3D quadrilateral geometry with bi-linear shape functions. More...
 
class  Quadrilateral3D8
 A eight node 3D quadrilateral geometry with quadratic shape functions. More...
 
class  Quadrilateral3D9
 A nine node 3D quadrilateral geometry with quadratic shape functions. More...
 
class  QuadrilateralInterface2D4
 
class  QuadrilateralInterface3D4
 
class  Sphere3D1
 
class  SurfaceInNurbsVolumeGeometry
 
class  Tetrahedra3D10
 A ten node tetrahedra geometry with quadratic shape functions. More...
 
class  Tetrahedra3D4
 A four node tetrahedra geometry with linear shape functions. More...
 
class  Triangle2D10
 A ten node 2D triangular geometry with cubic shape functions. More...
 
class  Triangle2D15
 A fifteen node 2D triangular geometry with quartic shape functions. More...
 
class  Triangle2D3
 A three node 2D triangle geometry with linear shape functions. More...
 
class  Triangle2D6
 A six node 2D triangular geometry with quadratic shape functions. More...
 
class  Triangle3D3
 A three node 3D triangle geometry with linear shape functions. More...
 
class  Triangle3D6
 A six node 3D triangular geometry with quadratic shape functions. More...
 
class  Accessor
 This class defines the way a certain property is accessed. More...
 
class  KratosZeroMatrix
 
class  KratosZeroVector
 
class  scalar_matrix
 
class  PermutationMatrix
 
class  Chunk
 Chunk is the smallest building block of Kratos memory management. More...
 
class  CodeLocation
 
class  Communicator
 The Commmunicator class manages communication for distributed ModelPart instances. More...
 
class  Condition
 Base class for all Conditions. More...
 
class  ConstitutiveLaw
 
class  ConvectionDiffusionSettings
 Convection diffusion settings. This class contains information to be used by the convection diffusion solver, all the variables that will be needed by the solver. More...
 
class  DataCommunicator
 Serial (do-nothing) version of a wrapper class for MPI communication. More...
 
struct  DofTrait
 
class  Dof
 Dof represents a degree of freedom (DoF). More...
 
class  Element
 Base class for all Elements. More...
 
class  Exception
 Extends the std::exception class with more information about error location. More...
 
class  FileSerializer
 
class  FillCommunicator
 Base class defining the API for the fill communicator utilities. More...
 
class  FixedSizeMemoryPool
 FixedSizeMemoryPool is the multi-thread manager of Kratos memory management. More...
 
class  FNV1a32Hash
 A constexpr version of FNV hash function. (32 bit version) More...
 
class  FNV1a64Hash
 A constexpr version of FNV hash function. (64 bit version) More...
 
class  GeometricalObject
 This defines the geometrical object, base definition of the element and condition entities. More...
 
class  GidGaussPointsContainer
 
class  GidIOBase
 Base class for GidIO. More...
 
class  GidIO
 This class defines an interface to the GiDPost library in order to provide GiD compliant I/O functionality. More...
 
class  GidMeshContainer
 
class  GlobalPointer
 This class is a wrapper for a pointer to a data that is located in a different rank. More...
 
struct  GlobalPointerHasher
 Template struct for hashing GlobalPointer instances. More...
 
struct  GlobalPointerComparor
 This is a key comparer between two dof pointers checking for equal keys. More...
 
struct  GlobalPointerCompare
 This is a key compare between two pointers to the object object. More...
 
class  IndexedObject
 This object defines an indexed object. More...
 
class  InitialState
 Define the initial state of the material in terms of initial stress/strain/F. More...
 
class  IO
 IO provides different implementation of input output procedures which can be used to read and write with different formats and characteristics. More...
 
class  KratosJsonIO
 An IO class for reading and writing a modelpart. More...
 
class  Kernel
 Kernel is in charge of synchronization the whole system of Kratos itself and its application. More...
 
struct  KeyComparorRange
 This is a key comparer of general pourpose between two classes. More...
 
struct  KeyHasherRange
 This is a hasher of general pourpose. More...
 
struct  VariableHasher
 This is a hasher for variables. More...
 
struct  VariableComparator
 This is a key comparer between two variables. More...
 
struct  pVariableHasher
 This is a hasher for variables pointers. More...
 
struct  pVariableComparator
 This is a key comparer between two variables pointers. More...
 
struct  IndexedObjectHasher
 This is a hasher for indexed objects. More...
 
struct  IndexedObjectComparator
 This is a key comparer between two indexed objects. More...
 
struct  IndexedObjectPointerHasher
 This is a hasher for indexed objects (pointer) More...
 
struct  IndexedObjectPointerComparator
 This is a key comparer between two indexed objects (pointer) More...
 
struct  SharedPointerHasher
 This is a hasher for shared pointers. More...
 
struct  SharedPointerComparator
 This is a key comparer between two shared pointers. More...
 
struct  VectorIndexHasher
 This is a hasher between two vectors of indexes. More...
 
struct  VectorIndexComparor
 This is a key comparer between two vectors of indexes. More...
 
struct  DofPointerHasher
 This is a hasher for a dof pointers. More...
 
struct  DofPointerComparor
 This is a key comparer between two dof pointers. More...
 
struct  PairHasher
 This is a hasher for pairs. More...
 
struct  PairComparor
 This is a key comparer between two indexes pairs. More...
 
class  KratosApplication
 This class defines the interface with kernel for all applications in Kratos. More...
 
class  KratosComponents
 KratosComponents class encapsulates a lookup table for a family of classes in a generic way. More...
 
class  KratosComponents< VariableData >
 
class  FilesystemExtensions
 
class  Parameters
 This class provides to Kratos a data structure for I/O based on the standard of JSON. More...
 
class  LockObject
 This class defines and stores a lock and gives an interface to it. More...
 
class  IndexDatabase
 Base class to derive common methods. More...
 
class  IndexSet
 Custom unordered set container to be used by the mapper. More...
 
class  IndexMap
 Custom unordered map container to be used by the mapper. More...
 
class  MasterSlaveConstraint
 A class that implements the interface for different master-slave constraints to be applied on a system. More...
 
class  MemoryInfo
 MemoryInfo gives the OS information about the memory usage by Kratos. More...
 
class  MemoryPool
 MemoryPool is the smallest building block of Kratos memory management. More...
 
class  Mesh
 Mesh is the second level of abstraction in the data structure which hold Nodes, Elements and Conditions and their Properties. More...
 
class  ModelPart
 This class aims to manage meshes for multi-physics simulations. More...
 
class  ModelPartIO
 An IO class for reading and writing a modelpart. More...
 
class  MortarKinematicVariables
 MortarKinematicVariables. More...
 
class  MortarKinematicVariablesWithDerivatives
 MortarKinematicVariablesWithDerivatives. More...
 
class  DerivativeData
 This data will be used to compute the derivatives. More...
 
class  DerivativeDataFrictional
 This class is a derived class of DerivativeData. More...
 
class  MortarOperator
 This is the definition of the mortar operator according to the work of Alexander Popp: https://www.lnm.mw.tum.de/staff/alexander-popp/. More...
 
class  MortarOperatorWithDerivatives
 This class derives from the MortarOperator class and it includes the derived operators. More...
 
class  DualLagrangeMultiplierOperators
 This is the definition dual lagrange multiplier operators according to the work of Alexander Popp: https://www.lnm.mw.tum.de/staff/alexander-popp/. More...
 
class  DualLagrangeMultiplierOperatorsWithDerivatives
 This is the definition dual lagrange multiplier operators including the derivatives. More...
 
class  PointBelong
 Custom Point container to be used by the mapper. More...
 
class  MpiSerializer
 
class  Neighbours
 Short class definition. More...
 
class  Node
 This class defines the node. More...
 
class  EnvironmentManager
 
class  ParallelEnvironment
 Holder for general data related to MPI (or suitable serial equivalents for non-MPI runs). More...
 
class  PeriodicCondition
 Condition used to assign periodic boundary conditions. More...
 
class  Table
 This class represents the value of its variable depending to other variable. More...
 
class  PoolObject
 This redefines the new and delete operators of derived class to be allocated in pool. More...
 
class  PrimeNumbers
 Gives a prime number before or after given number. More...
 
class  ProcessInfo
 ProcessInfo holds the current value of different solution parameters. More...
 
class  Properties
 Properties encapsulates data shared by different Elements or Conditions. It can store any type of data and provides a variable base access to them. More...
 
class  RadiationSettings
 Short class definition. More...
 
class  Registry
 Kratos base registry This class is intended to act as global registry Each time the AddItem method is called a pair of name and prototype is called. More...
 
class  RegistryAuxiliaries
 Kratos registry auxiliaries This static class collect all the auxiliary functions to be used to register c++ items. More...
 
class  RegistryItem
 The registry item to be stored by Registry class. It is the base class for some more specific ones. More...
 
class  ReorderConsecutiveModelPartIO
 An IO class for reading and writing a modelpart. More...
 
class  Serializer
 The serialization consists in storing the state of an object into a storage format like data file or memory buffer and also retrieving the object from such a media. More...
 
class  StreamSerializer
 
class  Table< double, double >
 
class  TableAccessor
 This class defines the way a certain property is accessed according to a table. More...
 
class  endl
 
class  TableStream
 This is a fancy table to stream data in a fancy way. More...
 
class  ThreadFixedSizeMemoryPool
 ThreadFixedSizeMemoryPool holds chunks belong to a certain thread and operate over them. More...
 
class  Base64EncodedOutput
 Encodes given iterator data to base 64 string representation. More...
 
class  CadJsonInput
 
class  CadJsonOutput
 
class  FileLoggerOutput
 FileLoggerOutput is a class for all file logger outputs. More...
 
class  Logger
 Logger is in charge of writing the messages to output streams. More...
 
class  LoggerMessage
 LoggerMessage class holdes message and the properties of the message. More...
 
class  LoggerOutput
 LoggerOutput is the base class for all logger outputs. More...
 
class  LoggerTableOutput
 LoggerTableOutput takes columns names and only prints the messages with lable given with column name. More...
 
class  StlIO
 This class reads from STL file format and creates triangular elements in given model_part. More...
 
class  UnvOutput
 Provides a tool to write UNV files. More...
 
class  VtkDefinitions
 
class  VtkOutput
 VtkOutput A simple class that has functionality to write vtk output. More...
 
class  VtuOutput
 Class to output Kratos Flags, Variables and ContainerExpressions to vtu. Supports both shared and distributed memory architectures. More...
 
class  HexahedronGaussLegendreIntegrationPoints1
 
class  HexahedronGaussLegendreIntegrationPoints2
 
class  HexahedronGaussLegendreIntegrationPoints3
 
class  HexahedronGaussLegendreIntegrationPoints4
 
class  HexahedronGaussLegendreIntegrationPoints5
 
class  HexahedronGaussLobattoIntegrationPoints1
 
class  HexahedronGaussLobattoIntegrationPoints2
 
class  IntegrationInfo
 Integration information for the creation of integration points. More...
 
class  IntegrationPoint
 Short class definition. More...
 
class  IntegrationPointUtilities
 
class  LineCollocationIntegrationPoints1
 
class  LineCollocationIntegrationPoints2
 
class  LineCollocationIntegrationPoints3
 
class  LineCollocationIntegrationPoints4
 
class  LineCollocationIntegrationPoints5
 
class  LineGaussLegendreIntegrationPoints1
 
class  LineGaussLegendreIntegrationPoints2
 
class  LineGaussLegendreIntegrationPoints3
 
class  LineGaussLegendreIntegrationPoints4
 
class  LineGaussLegendreIntegrationPoints5
 
class  LineGaussLegendreIntegrationPoints6
 
class  LineGaussLegendreIntegrationPoints7
 
class  LineGaussLegendreIntegrationPoints8
 
class  LineGaussLegendreIntegrationPoints9
 
class  LineGaussLegendreIntegrationPoints10
 
class  LineGaussLobattoIntegrationPoints1
 
class  LineGaussLobattoIntegrationPoints2
 
class  LineGaussLobattoIntegrationPoints3
 
class  LineGaussLobattoIntegrationPoints4
 
class  LineGaussLobattoIntegrationPoints5
 
class  LineGaussLobattoIntegrationPoints6
 
class  LineGaussLobattoIntegrationPoints7
 
class  LineGaussLobattoIntegrationPoints8
 
class  LineGaussLobattoIntegrationPoints9
 
class  LineGaussLobattoIntegrationPoints10
 
class  PrismGaussLegendreIntegrationPoints1
 
class  PrismGaussLegendreIntegrationPoints2
 
class  PrismGaussLegendreIntegrationPoints3
 
class  PrismGaussLegendreIntegrationPoints4
 
class  PrismGaussLegendreIntegrationPoints5
 
class  PrismGaussLegendreIntegrationPointsExt1
 
class  PrismGaussLegendreIntegrationPointsExt2
 
class  PrismGaussLegendreIntegrationPointsExt3
 
class  PrismGaussLegendreIntegrationPointsExt4
 
class  PrismGaussLegendreIntegrationPointsExt5
 
class  PrismGaussLobattoIntegrationPoints1
 
class  PrismGaussLobattoIntegrationPoints2
 
class  PyramidGaussLegendreIntegrationPoints1
 
class  PyramidGaussLegendreIntegrationPoints2
 
class  PyramidGaussLegendreIntegrationPoints3
 
class  PyramidGaussLegendreIntegrationPoints4
 
class  PyramidGaussLegendreIntegrationPoints5
 
struct  Pow
 
struct  Pow< 1 >
 
class  Quadrature
 Short class definition. More...
 
class  QuadrilateralCollocationIntegrationPoints1
 
class  QuadrilateralCollocationIntegrationPoints2
 
class  QuadrilateralCollocationIntegrationPoints3
 
class  QuadrilateralCollocationIntegrationPoints4
 
class  QuadrilateralCollocationIntegrationPoints5
 
class  QuadrilateralGaussLegendreIntegrationPoints1
 
class  QuadrilateralGaussLegendreIntegrationPoints2
 
class  QuadrilateralGaussLegendreIntegrationPoints3
 
class  QuadrilateralGaussLegendreIntegrationPoints4
 
class  QuadrilateralGaussLegendreIntegrationPoints5
 
class  QuadrilateralGaussLobattoIntegrationPoints1
 
class  QuadrilateralGaussLobattoIntegrationPoints2
 
class  TetrahedronGaussLegendreIntegrationPoints1
 
class  TetrahedronGaussLegendreIntegrationPoints2
 
class  TetrahedronGaussLegendreIntegrationPoints3
 
class  TetrahedronGaussLegendreIntegrationPoints4
 
class  TetrahedronGaussLegendreIntegrationPoints5
 
class  TriangleCollocationIntegrationPoints1
 
class  TriangleCollocationIntegrationPoints2
 
class  TriangleCollocationIntegrationPoints3
 
class  TriangleCollocationIntegrationPoints4
 
class  TriangleCollocationIntegrationPoints5
 
class  TriangleGaussLegendreIntegrationPoints1
 
class  TriangleGaussLegendreIntegrationPoints2
 
class  TriangleGaussLegendreIntegrationPoints3
 
class  TriangleGaussLegendreIntegrationPoints4
 
class  TriangleGaussLegendreIntegrationPoints5
 
class  TriangleGaussRadauIntegrationPoints1
 
class  TriangleGaussRadauIntegrationPoints2
 
class  TriangleGaussRadauIntegrationPoints3
 
class  TriangleGaussRadauIntegrationPoints4
 
class  TriangleGaussRadauIntegrationPoints5
 
class  TriangleGaussRadauIntegrationPoints6
 
class  AMGCL_NS_Solver
 
class  AMGCLSolver
 This is a multigrid solver based on the AMGCL library. More...
 
class  BICGSTABSolver
 Short class definition. More...
 
class  CGSolver
 Short class definition. More...
 
class  DeflatedCGSolver
 Short class definition. More...
 
class  DiagonalPreconditioner
 DiagonalPreconditioner class. More...
 
class  DirectSolver
 
class  ILU0Preconditioner
 ILU0Preconditioner class. More...
 
class  ILUPreconditioner
 ILUPreconditioner class. More...
 
class  IterativeSolver
 Base class for all the iterative solvers in Kratos. More...
 
class  LinearSolver
 Base class for all the linear solvers in Kratos. More...
 
class  MonotonicityPreservingSolver
 
class  PowerIterationEigenvalueSolver
 This class uses the inverted power iteration method to obtain the lowest eigenvalue of a system. More...
 
class  PowerIterationHighestEigenvalueSolver
 This class uses the inverted power iteration method to obtain the lowest eigenvalue of a system. More...
 
class  Preconditioner
 Preconditioner class. More...
 
class  RayleighQuotientIterationEigenvalueSolver
 This is a eigen solver based on the Rayleigh quotient iteration algorithm. More...
 
class  Reorderer
 Base class for all reorderer objects in Kratos used in linear solvers. More...
 
class  ScalingSolver
 This solvers rescales in order to improve the conditioning of the system. More...
 
class  SkylineLUCustomScalarSolver
 
class  LUSkylineFactorization
 
class  SkylineLUFactorizationSolver
 
class  TFQMRSolver
 
class  Mapper
 Base Class for all Mappers. More...
 
class  MapperFlags
 Flags needed used in the MappingApplication. More...
 
class  CadIoModeler
 Short class definition. More...
 
class  CartesianMeshGeneratorModeler
 Short class definition. More...
 
class  CombineModelPartModeler
 This modeler combines several model parts into a new one. All input model parts should share the same root model part. More...
 
class  ConnectivityPreserveModeler
 A tool to generate a copy of a ModelPart, sharing the same nodes as the original. More...
 
class  CopyPropertiesModeler
 Copy the properties from one model part to another. More...
 
class  CreateEntitiesFromGeometriesModeler
 Modeler to create element/condition entities from geometries. More...
 
class  DuplicateMeshModeler
 Short class definition. More...
 
class  EdgeSwapping2DModeler
 Optimizes a 2D mesh by swapping the edges between elements. More...
 
class  MeshSuiteModeler
 Short class definition. More...
 
class  Modeler
 Modeler to interact with ModelParts. More...
 
class  SerialModelPartCombinatorModeler
 This modeler combines several model parts in serial, reading its respective *.mdpa files (maybe others in the future) More...
 
class  StructuredMeshRefinementModeler
 Short class definition. More...
 
class  TetrahedraBall
 Stores a ball of tetrahedra sourronding a node of mesh. More...
 
class  TetrahedraEdgeShell
 This class defines an edge shell for a mesh of tetrahedra. More...
 
class  AusasModifiedShapeFunctions
 
class  ModifiedShapeFunctions
 
class  Tetrahedra3D4AusasIncisedShapeFunctions
 
class  Tetrahedra3D4AusasModifiedShapeFunctions
 
class  Tetrahedra3D4ModifiedShapeFunctions
 
class  Triangle2D3AusasIncisedShapeFunctions
 
class  Triangle2D3AusasModifiedShapeFunctions
 
class  Triangle2D3ModifiedShapeFunctions
 
class  MPICommunicator
 MPICommunicator manages the transfer of ModelPart data in MPI distributed memory environment. More...
 
class  MPIDataCommunicator
 Wrapper for common MPI calls within Kratos. More...
 
class  MPIManager
 Helper class to manage the MPI lifecycle. More...
 
class  MPIMessage
 
class  AmgclDistributedCSRConversionUtilities
 
class  DistributedAmgclCSRSpMMUtilities
 
class  MpiDebugUtilities
 
class  DistributedModelPartInitializer
 Initialize a distributed ModelPart from a serial one. More...
 
class  GatherModelPartUtility
 
class  ModelPartCommunicatorUtilities
 Utilitiy class for ModelPart::Comunicator management in an MPI context. More...
 
class  MPINormalCalculationUtils
 Some tools to calculate face and nodal normals on an MPI partitioned environment. More...
 
class  ParallelFillCommunicator
 This function recomputes the communication plan for MPI. More...
 
class  Operation
 The base class for all operations in Kratos. More...
 
class  ApplyConstantScalarValueProcess
 The base class for all processes in Kratos. More...
 
class  ApplyConstantVectorValueProcess
 The base class for all processes in Kratos. More...
 
class  ApplyPeriodicConditionProcess
 
class  ApplyRayCastingInterfaceRecognitionProcess
 Applies ray casting to distinguish the color (like in/out) of each node in modelpart. More...
 
class  ApplyRayCastingProcess
 Applies ray casting to distinguish the color (like in/out) of each node in modelpart. More...
 
class  AssignScalarFieldToEntitiesProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
struct  AssignScalarInputToEntitiesProcessSettings
 This struct is used in order to identify when using the hitorical and non historical variables. More...
 
class  AssignScalarInputToEntitiesProcess
 This function assigns a value from an input to a variable belonging to all of the entities in a given mesh. More...
 
class  AssignScalarVariableToEntitiesProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  CalculateDiscontinuousDistanceToSkinProcessFlags
 
class  CalculateDiscontinuousDistanceToSkinProcess
 This only calculates the distance. Calculating the inside outside should be done by a derived class of this. More...
 
struct  CalculateDistanceToPathSettings
 This struct is used in order to identify when using the hitorical and non historical variables. More...
 
class  CalculateDistanceToPathProcess
 Computes DISTANCE from a path model part to a given model part. More...
 
class  CalculateDistanceToSkinProcess
 Calculates the nodal distances using elemental discontinuous distances. More...
 
class  EmbeddedNodalVariableFromSkinTypeHelperClass
 
class  CalculateEmbeddedNodalVariableFromSkinProcess
 
class  CalculateEmbeddedSignedDistanceTo3DSkinProcess
 Short class definition. More...
 
struct  CalculateNodalAreaSettings
 This struct is used in order to identify when using the hitorical and non historical variables. More...
 
class  CalculateNodalAreaProcess
 Computes NODAL_AREA. More...
 
class  DistanceSpatialContainersConditionConfigure
 
class  CalculateSignedDistanceTo3DConditionSkinProcess
 Short class definition. More...
 
class  DistanceSpatialContainersConfigure
 
class  CalculateSignedDistanceTo3DSkinProcess
 Short class definition. More...
 
class  CheckSameModelPartUsingSkinDistanceProcess
 Checks that the model part is the same using the skin distance. More...
 
class  CheckSkinProcess
 This function verifies that the skin has no holes nor overlapped geometries this is accomplished by storing all of the edges in the model in a hash map and verifying that no edge appears more than twice (which would imply an overlap) or less than once (which would imply a gap in the skin) More...
 
struct  ComputeNodalGradientProcessSettings
 This struct is used in order to identify when using the hitorical and non historical variables. More...
 
struct  AuxiliarVariableVectorRetriever
 This struct is an auxiliar base class of the VariableVectorRetriever. More...
 
struct  VariableVectorRetriever
 This struct is used in order to retrieve values without loosing performance. More...
 
class  ComputeNodalGradientProcess
 Compute Nodal Gradient process. More...
 
struct  ComputeNodalDivergenceProcessSettings
 This struct is used in order to identify when using the hitorical and non historical variables. More...
 
class  ComputeNodalNormalDivergenceProcess
 Compute Nodal Normal Divergence process. More...
 
class  ConstructSystemMatrixElementalProcess
 Short class definition. More...
 
class  EdgeBasedGradientRecoveryProcess
 Edge-based gradient recovery process This process implements the edge-based gradient recovery process technique described in https://onlinelibrary.wiley.com/doi/epdf/10.1002/nme.4374. More...
 
class  EliminateIsolatedNodesProcess
 Short class definition. More...
 
class  EntitiesEraseProcessFlags
 
class  EntitiesEraseProcess
 This process removes the entities from a model part with the flag TO_ERASE. More...
 
class  FastTransferBetweenModelPartsProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  FindConditionsNeighboursProcess
 Short class definition. More...
 
class  FindGlobalNodalElementalNeighboursProcess
 Short class definition. More...
 
class  FindGlobalNodalEntityNeighboursProcess
 Short class definition. More...
 
class  FindNodalNeighboursForEntitiesProcess
 Short class definition. More...
 
class  FindGlobalNodalNeighboursProcess
 Short class definition. More...
 
class  FindIntersectedGeometricalObjectsProcess
 This class takes two modelparts and marks the intersected ones with SELECTED flag. More...
 
class  FindIntersectedGeometricalObjectsWithOBBProcess
 This class takes two modelparts and marks the intersected ones with SELECTED flag. Does the check considering an OBB for the intersection. More...
 
struct  FindNodalHSettings
 This struct is used in order to identify when using the hitorical and non historical variables. More...
 
class  FindNodalHProcess
 Computes NODAL_H. More...
 
class  FindNodalNeighboursProcess
 This method allows to look for neighbours in a triangular or tetrahedral mesh. More...
 
class  FluxCorrectedTransportConvectionProcess
 Process to solve a pure convection problem using a Flux Corrected Transport scheme and an edge-based data structure. More...
 
class  FromJSONCheckResultProcess
 This class is used in order to check results using a json file containing the solution a given model part with a certain frequency. More...
 
class  GenericFindElementalNeighboursProcess
 
class  GraphColoringProcess
 Getting a graph of connectivities (of domains) and performs a coloring procedure. More...
 
class  IntegrationValuesExtrapolationToNodesProcess
 This process extrapolates vales from the integration points to the nodes. More...
 
class  LevelSetConvectionProcess
 Short class definition. More...
 
class  MeasureMeshQualityProcess
 Short class definition. More...
 
class  MeshCoarseningProcess
 Short class definition. More...
 
class  MeshLocalSmoothingProcess
 The base class for local smoothing processes providing a laplacian smoothing. More...
 
class  MeshNodeCollapsingProcess
 Remove the selected node from the mesh and collapse the connectivity arround it. More...
 
class  OutputProcess
 The base class for output processes. More...
 
class  ParallelDistanceCalculationProcess
 Short class definition. More...
 
class  Process
 The base class for all processes in Kratos. More...
 
class  ReorderAndOptimizeModelPartProcess
 Short class definition. More...
 
class  ReplaceElementsAndConditionsProcess
 This methods replaces elements and conditions in a model part by a given name. More...
 
class  SetInitialStateProcess
 The SetInitialStateProcess. More...
 
class  SimpleMortarMapperProcess
 This is basic mapper of values between domains using mortar formulation. More...
 
class  SimpleMortarMapperProcessWrapper
 This class wraps automatically the different types mof mappers. More...
 
class  SkinDetectionProcess
 An algorithm that looks for neighbour elements in a mesh and creates a submodelpart containing the skin of the disconnected elements (interface elements) More...
 
class  SplitInternalInterfacesProcess
 Computes NODAL_AREA. More...
 
class  StructuredMeshGeneratorProcess
 Short class definition. More...
 
class  SubModelPartSkinDetectionProcess
 Create a SubModelPart covering a part of the outside skin of the computation domain where a condition is met. More...
 
class  TetrahedraMeshEdgeSwappingProcess
 Short class definition. More...
 
class  TetrahedraMeshQualityWeightedSmoothingProcess
 Short class definition. More...
 
class  TetrahedraMeshWorstElementSmoothingProcess
 Short class definition. More...
 
class  TetrahedralMeshOrientationCheck
 Check a triangular or tetrahedral mesh to ensure that local connectivities follow the expected convention. More...
 
class  TimeAveragingProcess
 
class  VariationalDistanceCalculationProcess
 Short class definition. More...
 
class  AdjointResponseFunction
 A base class for adjoint response functions. More...
 
class  BuilderAndSolver
 Current class provides an implementation for the base builder and solving operations. More...
 
class  ExplicitBuilder
 Current class provides an implementation for the base explicit builder and solving operations. More...
 
class  ResidualBasedBlockBuilderAndSolver
 Current class provides an implementation for standard builder and solving operations. More...
 
class  ResidualBasedBlockBuilderAndSolverWithLagrangeMultiplier
 Current class provides an implementation for standard builder and solving operations. More...
 
class  ResidualBasedEliminationBuilderAndSolver
 Current class provides an implementation for standard elimination builder and solving operations. More...
 
class  ResidualBasedEliminationBuilderAndSolverComponentwise
 
class  ResidualBasedEliminationBuilderAndSolverWithConstraints
 Current class provides an implementation for standard builder and solving operations. More...
 
class  ConvergenceAccelerator
 Base class for convergence accelerators This class is intended to be the base of any convergence accelerator in Kratos. More...
 
class  And_Criteria
 This convergence criteria checks simultaneously two convergence criteria (both must be satisfied) More...
 
class  ConvergenceCriteria
 This is the base class to define the different convergence criterion considered. More...
 
class  DisplacementCriteria
 This is a convergence criteria that considers the increment on the solution as criteria. More...
 
class  MixedGenericCriteria
 Convergence criteria for mixed vector-scalar problems. More...
 
class  Or_Criteria
 This convergence criteria checks simultaneously two convergence criteria (one of them must be satisfied) More...
 
class  ResidualCriteria
 This is a convergence criteria that considers the residual as criteria. More...
 
class  ResidualBasedAdjointBossakScheme
 A scheme for dynamic adjoint equations, using Bossak time integration. More...
 
class  ResidualBasedAdjointStaticScheme
 A scheme for static adjoint equations. More...
 
class  ResidualBasedAdjointSteadyScheme
 A scheme for steady adjoint equations. More...
 
class  ResidualBasedBDFCustomScheme
 BDF integration scheme (for dynamic problems) More...
 
class  ResidualBasedBDFDisplacementScheme
 BDF integration scheme (displacement based) More...
 
class  ResidualBasedBDFScheme
 BDF integration scheme (for dynamic problems) More...
 
class  ResidualBasedBossakDisplacementScheme
 Bossak integration scheme (for linear and nonlinear dynamic problems) for displacements. More...
 
class  ResidualBasedImplicitTimeScheme
 This is the base class for the implicit time schemes. More...
 
class  ResidualBasedNewmarkDisplacementScheme
 Bossak integration scheme (for dynamic problems) for displacements. More...
 
class  ResidualBasedPseudoStaticDisplacementScheme
 This is a pseudo-static scheme. More...
 
class  ResidualBasedIncrementalAitkenStaticScheme
 A scheme for the solution of a problem using Aitken iterations. More...
 
class  ResidualBasedIncrementalUpdateStaticScheme
 This class provides the implementation of a static scheme. More...
 
class  ResidualBasedIncrementalUpdateStaticSchemeSlip
 Scheme for the solution of problems involving a slip condition. More...
 
class  Scheme
 This class provides the implementation of the basic tasks that are needed by the solution strategy. More...
 
class  SensitivityBuilderScheme
 Scheme used in the Sensitivity Builder. More...
 
class  AdaptiveResidualBasedNewtonRaphsonStrategy
 Short class definition. More...
 
class  ArcLengthStrategy
 This is the base ArcLengthStrategy. More...
 
class  ButcherTableau
 Butcher tableau for Runge-Kutta method. More...
 
class  ButcherTableauForwardEuler
 
class  ButcherTableauMidPointMethod
 
class  ButcherTableauRK3TVD
 Explicit total variation diminishing 3rd order Runge-Kutta. More...
 
class  ButcherTableauRK4
 
class  ExplicitSolvingStrategy
 Explicit solving strategy base class. More...
 
class  ExplicitSolvingStrategyBFECC
 Explicit Back-and-Forth Error Compensation Correction time-integration scheme. More...
 
class  ExplicitSolvingStrategyRungeKutta
 Family of explicit Runge-Kutta schemes. More...
 
class  ImplicitSolvingStrategy
 Implicit solving strategy base class This is the base class from which we will derive all the implicit strategies (line-search, NR, etc...) More...
 
class  LineSearchStrategy
 Short class definition. More...
 
class  ResidualBasedLinearStrategy
 This is a very simple strategy to solve linearly the problem. More...
 
class  ResidualBasedNewtonRaphsonStrategy
 This is the base Newton Raphson strategy. More...
 
class  SolvingStrategy
 Solving strategy base class This is the base class from which we will derive all the strategies (implicit and explicit) More...
 
class  KratosSpace
 Short class definition. More...
 
class  UblasSpace
 A class template for handling data types, matrices, and vectors in a Ublas space. More...
 
class  BinsDynamic
 A dynamic binning data structure template for organizing and querying points in multi-dimensional space. More...
 
class  BinsObjectDynamic
 Short class definition. More...
 
class  Bins
 
class  BinsObjectStatic
 Short class definition. More...
 
class  kDOP
 
class  _6DOP
 
class  _8DOP
 
class  _12DOP
 
class  _14DOP
 
class  _18DOP
 
class  _20DOP
 
class  _26DOP
 
class  BoundingVolumePartitioner
 
class  SimpleBoundingVolumePartitioner
 
class  LineRegressionVolumePartitioner
 
class  BoundingVolumeTree
 
class  Bucket
 Short class definition. More...
 
class  Cell
 
class  NodeConfigure
 Configuration file for Nodes. More...
 
class  PointDistance2
 Short class definition. More...
 
class  RadiusPoint
 
class  DEMSearch
 
class  GeometricalObjectsBins
 A bins container for 3 dimensional GeometricalObject entities. More...
 
class  KDTreePartitionBase
 Short class definition. More...
 
class  KDTreePartition
 
class  KDTreePartitionAverageSplit
 
class  KDTreePartitionMidPointSplit
 
class  OcTreeAverageSplit
 
class  OcTreeMidPointSplit
 
class  OCTreePartition
 Short class definition. More...
 
class  OctreeBinary
 Short class definition. More...
 
class  OctreeBinaryCell
 This class represents a cell in an octree to be used with Octree class. More...
 
class  PointObject
 Custom Point container to be used by the search. More...
 
class  Tvector
 Short class definition. More...
 
class  SubBinAxis
 TOOLS UTILS ///. More...
 
class  SearchStructure
 
class  SpatialSearch
 This class is used to search for elements, conditions and nodes in a given model part. More...
 
class  SpatialSearchResult
 This class is the result of the spatial searches. More...
 
class  SpecializedSpatialSearch
 This class is used to search for elements, conditions and nodes in a given model part. More...
 
class  SpecializedSpatialSearchFactory
 Factory for the specialized spatial search. More...
 
class  TreeNode
 Short class definition. More...
 
class  Tree
 A generic tree data structure for spatial partitioning. More...
 
class  TestSkippedException
 Exception type used to signal that a test should be skipped. More...
 
class  ActivationUtilities
 Tool to evaluate the normals on nodes based on the normals of a set of surface conditions. More...
 
class  AdjointExtensions
 Interface extensions for adjoint elements and conditions. More...
 
class  AmgclCSRConversionUtilities
 
class  AmgclCSRSpMMUtilities
 
class  ApplyFunctionToNodesUtility
 This function applies a givn function to its nodes calling GenericFunctionUtility. More...
 
class  AssignMasterSlaveConstraintsToNeighboursUtility
 Assing Master-Slave Constraints to Neighbouring Nodes. More...
 
class  AssignUniqueModelPartCollectionTagUtility
 Get the collection of submodelparts each node, condition and element belongs to. More...
 
class  AuxiliarModelPartUtilities
 This utility includes auxiliar methods not included in the model part to avoid increase more than necessary the API. More...
 
class  BeamMathUtils
 
class  BinBasedFastPointLocator
 This class is designed to allow the fast location of MANY points on the top of a 3D mesh. More...
 
class  BinBasedFastPointLocatorConditions
 This class is designed to allow the fast location of MANY points on the top of a 3D mesh. (for conditions) More...
 
class  BinBasedNodesInElementLocator
 REMARK: the location function is threadsafe, and can be used in OpenMP loops. More...
 
class  BodyDistanceCalculationUtils
 
class  BodyNormalCalculationUtils
 
class  BrentIteration
 
class  BruteForcePointLocator
 Utility class to find an entity of a mesh based on a location. More...
 
class  BuiltinTimer
 
class  MPIColoringUtilities
 This class provides elementary function for computing the recv list and to define a coloring for communications. More...
 
class  CompareElementsAndConditionsUtility
 
class  ComputeNeighbourListFunctor
 Short class definition. More...
 
class  ConditionNumberUtility
 Utility to compute the condition number. More...
 
class  ParticleConvectUtily
 
class  CoordinateTransformationUtils
 
class  Counter
 Short class definition. More...
 
class  CurveAxisIntersection
 
class  CuttingUtility
 CUTTING UTILITY. More...
 
class  DataTypeTraits
 Generic data type traits class for arithmetic types. More...
 
class  DataTypeTraits< array_1d< TDataType, TSize > >
 Data type traits for array_1d data types. More...
 
class  DataTypeTraits< DenseVector< TDataType > >
 Data type traits for DenseVector data types. More...
 
class  DataTypeTraits< DenseMatrix< TDataType > >
 
class  DataTypeTraits< std::string >
 
class  DataTypeTraits< std::vector< TDataType > >
 
class  DeflationUtils
 
class  DenseHouseholderQRDecomposition
 
class  DenseQRDecomposition
 
class  DenseSingularValueDecomposition
 
class  DiscontinuousShapeFunctionsUtilities_2D
 This utility can be used to calculate the enriched shape function for tetrahedra element. More...
 
class  DiscontinuousShapeFunctionsUtilities
 
class  IndexedPoint
 
class  DivideGeometry
 
class  DivideTetrahedra3D4
 
class  DivideTriangle2D3
 
class  DivideTriangle3D3
 
class  DofUpdater
 Utility class to update the values of degree of freedom (Dof) variables after solving the system. More...
 
class  ElementSizeCalculator
 A collection of functions to compute element size, to be used as the h parameter in stabilized CFD formulations. More...
 
class  EmbeddedSkinUtility
 Utility to compute the skin representation from a distance function. More...
 
class  EnrichmentUtilities_2D
 This utility can be used to calculate the enriched shape function for tetrahedra element. More...
 
class  EnrichmentUtilities
 
class  EnrichmentUtilitiesDuplicateDofs
 
class  ExactMortarIntegrationUtility
 This utility calculates the exact integration necessary for the Mortar Conditions. More...
 
class  FileNameDataCollector
 
class  ForceAndTorqueUtils
 
class  BasicGenericFunctionUtility
 This function allows to call a function method of type f(x, y, z, t) implemented in python style. More...
 
class  GenericFunctionUtility
 GenericFunctionUtility. More...
 
class  FunctionParser
 GenericFunctionUtility. More...
 
class  GeometricalProjectionUtilities
 This is a class that provides auxiliar utilities for projections. More...
 
struct  ShapeParameter
 
class  GeometricalSensitivityUtility
 
class  GeometryMetricCalculator
 
class  GeometryTesterUtility
 This utility tests the geometries. More...
 
class  BrepTrimmingUtilities
 
class  NearestPointUtilities
 Tools to calculate the nearest point in different geometries. More...
 
class  GeometryUtils
 This function provides basic routines for working with simplicial meshes. More...
 
class  GetValueFunctor
 Short class definition. More...
 
class  GlobalPointerUtilities
 This class is used to manage global pointers. Overall, the GlobalPointerUtilities class provides a useful utility for retrieving global pointers to entities in a distributed Kratos simulation. More...
 
class  IndirectScalar
 Wrapper for a function which behaves like an arithmetic type. More...
 
class  IntegrationUtilities
 Utilities to integrate in different cases. More...
 
class  IntersectionUtilities
 Utilities to compute intersections between different geometries. More...
 
class  IntervalUtility
 
class  IsosurfacePrinterApplication
 
class  LineSensitivityUtility
 
class  MathUtils
 Various mathematical utilitiy functions. More...
 
class  MergeVariableListsUtility
 Merges the variable lists of the input modelparts. More...
 
class  MLSShapeFunctionsUtility
 Moving Least-Squares utility to calculate shape function values This class uses a linear polynomial basis and an exponential kernel to calculate the shape function values and gradients in a given point using a Moving Least-Squares minimization. More...
 
class  ModelPartCombinationUtilities
 This utility helps combine different ModelParts into one single ModelPart, with the corresponding sub ModelParts. More...
 
class  ModelPartGraphUtilities
 This file computes the graph representing the connectivity of a modelpart. More...
 
class  ModelPartOperationUtilities
 
struct  ModelPartUnionOperator
 
struct  ModelPartSubstractionOperator
 
struct  ModelPartIntersectionOperator
 
class  ModelPartUtils
 Class collecting a set of free-floating utility functions for querying and mutating ModelPart s. More...
 
struct  MortarUtilitiesSettings
 This struct is used in order to identify when using the historical and non historical variables. More...
 
class  NormalCalculationUtils
 
class  ProjectionNurbsGeometryUtilities
 
class  ObjectCounter
 Short class definition. More...
 
class  OpenMPUtils
 Implements basic tasks for OpenMP parallelism and suitable scalar alternatives. More...
 
class  ParallelUtilities
 Shared memory parallelism related helper class. More...
 
class  BlockPartition
 
class  IndexPartition
 This class is useful for index iteration over containers. More...
 
class  ParticlesUtilities
 Collection of utilities to compute statistic of particles. More...
 
class  PlaneApproximationUtility
 Utility to compute an approximation plane for a set of points. More...
 
class  GlobalPointerCommunicator
 A template class for handling communication related to global pointers. More...
 
class  ResultsProxy
 A template class to proxy results, whether they are locally or remotely owned. More...
 
class  GlobalPointerMapCommunicator
 Short class definition. More...
 
class  ApplyProxy
 Proxy class to update local and non-local data. More...
 
class  ContainerProxy
 A view with a uniform interface for ModelPart::NodesContainerType, ModelPart::ElementsContainerType, or ModelPart::ConditionsContainerType. More...
 
class  EntityProxy
 Wrapper class providing a uniform interface for historical/non-historical Node, Element, and Condition. More...
 
class  PythonGenericFunctionUtility
 This function allows to call a function method of type f(x, y, z, t) implemented in python. More...
 
class  QuadraticErrorFunction
 Utilities to compute the minimum error point in a 3D voxel intersected by a triangle mesh This implementation is based on the algorithm explained here: https://www.mattkeeter.com/projects/qef/. More...
 
class  CreateQuadraturePointsUtility
 A Class for the creation of integration points. More...
 
class  Quaternion
 Quaternion A simple class that implements the main features of quaternion algebra. More...
 
class  RandomInitializeUtility
 Utility to initialize a random vector. More...
 
class  RBFShapeFunctionsUtility
 Radial Basis Functions utility to calculate shape function values This class uses Gaussian raidal basis functions to calculate the shape function values for a given value (i.e. norm of a point) with partition of unity. More...
 
class  ReadAndSetAccessorsUtilities
 
class  ReadMaterialsUtility
 Process to read constitutive law and material properties from a json file. More...
 
class  SumReduction
 utility function to do a sum reduction More...
 
class  SubReduction
 
class  MaxReduction
 
class  AbsMaxReduction
 
class  MinReduction
 
class  AbsMinReduction
 
class  AccumReduction
 
class  MapReduction
 
struct  CombinedReduction
 
class  EntityDatabase
 This class stores the results of a entity. More...
 
class  VariableDatabase
 This class stores the results of a variable. More...
 
class  ResultDatabase
 This class stores the results of a simulation for a later comparison. More...
 
class  RetrieveGlobalPointersByIndex
 Short class definition. More...
 
class  RVEPeriodicityUtility
 This defines a class to define periodic BC to a RVE. More...
 
struct  DistributedSearchInformation
 This struct provides information related with distributed search. More...
 
class  SearchUtilities
 MPI utilities for searching geometrical objects. More...
 
class  SensitivityBuilder
 
class  SensitivityUtilities
 
class  ShiftedBoundaryMeshlessInterfaceUtility
 Utilities for the SBM-WTE extension operator calculation This class encapsulates several utilities for the calculation of the extension operator in the Shifted Boundary Method Without Taylor Expansions. More...
 
class  SignedDistanceCalculationUtils
 
class  SingleImportModelPart
 
class  SparseMatrixMultiplicationUtility
 An utility to multiply sparse matrix in Ublas. More...
 
class  SpatialContainersConfigure
 Thhis class is a container for spatial search. More...
 
class  SpecificationsUtilities
 This namespace includes several utilities necessaries for evaluate specifications. More...
 
class  TetrahedraSplit
 This class performs the splitting of a tetrahedra. It contains three helper functions to ease the splitting: TetrahedraSplitMode, Split_Tetrahedra, and TetrahedraGetNewConnectivityGID. More...
 
class  SplitTetrahedraUtilities
 
class  TriangleSplit
 
class  SubModelPartEntitiesBooleanOperationUtility
 Wrapper of boolean operations: union, intersection and difference. More...
 
class  SVDUtils
 Various mathematical utilities to compute SVD and the condition number of a matrix. More...
 
class  TableStreamUtility
 
class  CurveTessellation
 
class  Timer
 This utility can be used to compute the time employed on computations. More...
 
class  VariableRedistributionUtility
 Helper utility to transform between point-wise nodal variables and distributed values. More...
 
class  VariableUtils
 This class implements a set of auxiliar, already parallelized, methods to perform some common tasks related with the variable values and fixity. More...
 
class  XmlExpressionElement
 
class  XmlOStreamAsciiWriter
 
class  XmlOStreamBase64BinaryWriter
 
class  XmlOStreamWriter
 
class  KratosCableNetApplication
 Short class definition. More...
 
class  EmpiricalSpringElement3D2N
 This spring reads a fitted polynomial as displacement-load curve takes u and returns f. More...
 
class  RingElement3D
 This is a ring elemen with 3 translational dofs per node. More...
 
class  SlidingCableElement3D
 This is a sliding node element with 3 translational dofs per node. More...
 
class  WeakSlidingElement3D3N
 This is a penalty element to realize sliding nodes element with 3 translational dofs per node. More...
 
class  Line3DN
 A arbitrary node 3D line geometry with quadratic shape functions. More...
 
class  ApplyWeakSlidingProcess
 
class  EdgeCableElementProcess
 
class  EmpiricalSpringElementProcess
 
class  CableNetMpcProcess
 
class  SlidingEdgeProcess
 
class  KratosChimeraApplication
 Short class definition. More...
 
class  ApplyChimera
 This class contains methods applies the continuity between the patch and background using linear master-slave constraints. More...
 
class  ApplyChimeraProcessFractionalStep
 This class extends ApplyChimera base class and overwrites the function ApplyContinuityWithMpcs to use different containers for storing pressure and velocity constraints. More...
 
class  ApplyChimeraProcessMonolithic
 This class extends ApplyChimera base class and overwrites the function ApplyContinuityWithMpcs to use same container for storing pressure and velocity constraints. More...
 
class  RotateRegionProcess
 This is the to apply rotation to a given modelpart. More...
 
class  ResidualBasedBlockBuilderAndSolverWithConstraintsForChimera
 Current class provides an implementation for applying the chimera constraints that is enforcing continuity. More...
 
class  FractionalStepStrategyForChimera
 
class  ChimeraDistanceCalculationUtility
 Utility for calculating the Distance on a given modelpart. More...
 
class  FractionalStepSettingsForChimera
 Helper class to define solution strategies for FS_Strategy. More...
 
class  ChimeraHoleCuttingUtility
 Short class definition. More...
 
class  KratosCompressiblePotentialFlowApplication
 Short class definition. More...
 
class  AdjointPotentialWallCondition
 
class  PotentialWallCondition
 Implements a wall condition for the potential flow formulation. More...
 
class  AdjointAnalyticalIncompressiblePotentialFlowElement
 
class  AdjointBasePotentialFlowElement
 
class  AdjointFiniteDifferencePotentialFlowElement
 
class  CompressiblePerturbationPotentialFlowElement
 
class  CompressiblePotentialFlowElement
 
class  EmbeddedCompressiblePotentialFlowElement
 
class  EmbeddedIncompressiblePotentialFlowElement
 
class  EmbeddedTransonicPerturbationPotentialFlowElement
 
class  IncompressiblePerturbationPotentialFlowElement
 
class  IncompressiblePotentialFlowElement
 
class  TransonicPerturbationPotentialFlowElement
 
class  PotentialToCompressibleNavierStokesOperation
 This operation pass the nodal velocities from Potential model part as initial condition of a compressible Navier Stokes model part in conservative variables form. More...
 
class  ApplyFarFieldProcess
 Auxiliary process to define the wake in 2 dimensional problems. More...
 
class  ComputeEmbeddedLiftProcess
 
class  ComputeNodalValueProcess
 
struct  ComputeWingSectionVariableProcessSettings
 
class  ComputeWingSectionVariableProcess
 
class  Define2DWakeProcess
 Auxiliary process to define the wake in 2 dimensional problems. More...
 
class  Define3DWakeProcess
 Auxiliary process to define the wake in 2 dimensional problems. More...
 
class  DefineEmbeddedWakeProcess
 
class  KuttaConditionProcess
 
class  MoveModelPartProcess
 
class  AdjointLiftFarFieldResponseFunction
 AdjointLiftFarFieldResponseFunction. More...
 
class  AdjointLiftJumpCoordinatesResponseFunction
 AdjointLiftJumpCoordinatesResponseFunction. More...
 
class  AdjointPotentialResponseFunction
 
class  KratosConstitutiveLawsApplication
 Short class definition. More...
 
class  GenericCompressionConstitutiveLawIntegratorDplusDminusDamage
 : This object integrates the predictive stress using the isotropic the d+d- damage theory More...
 
class  GenericTensionConstitutiveLawIntegratorDplusDminusDamage
 : This object integrates the predictive stress using the isotropic the d+d- damage theory More...
 
class  GenericConstitutiveLawIntegratorDamage
 : This object integrates the predictive stress using the isotropic damage theory by means of linear/exponential softening. More...
 
class  GenericConstitutiveLawIntegratorKinematicPlasticity
 This object integrates the predictive stress using the plasticity theory by means of linear/exponential softening or hardening + softening evolution laws. More...
 
class  GenericConstitutiveLawIntegratorPlasticity
 This object integrates the predictive stress using the plasticity theory by means of linear/exponential softening or hardening + softening evolution laws. More...
 
class  HighCycleFatigueLawIntegrator
 : This object computes all the required information for the high cycle fatigue constitutive law. More...
 
class  HCFDataContainer
 Defining all the methods and variables required in fatigue simulations. More...
 
class  DruckerPragerPlasticPotential
 This class defines a plastic potential following the theory of Drucker-Prager. More...
 
class  GenericPlasticPotential
 If the plastic potential is of the same type as the yield surface we talk about associated flow rules, if a different function is used, it is non-associated. For metals associated flow rules work great, while frictional materials typically need non-associated flow rules. More...
 
class  ModifiedMohrCoulombPlasticPotential
 This class defines a plastic potential following the theory of Mohr-Coulomb (modified) More...
 
class  MohrCoulombPlasticPotential
 This class defines a plastic potential following the theory of Mohr-Coulomb. More...
 
class  RankinePlasticPotential
 This class defines a plastic potential following the theory of Rankine. More...
 
class  TrescaPlasticPotential
 This class defines a plastic potential following the theory of Tresca. More...
 
class  VonMisesPlasticPotential
 This class defines a plastic potential following the theory of Von Mises. More...
 
class  DruckerPragerYieldSurface
 This class defines a yield surface according to Drucker-Prager theory. More...
 
class  GenericYieldSurface
 This class defines a generic yield surface. More...
 
class  ModifiedMohrCoulombYieldSurface
 This class defines a yield surface according to Modified Mohr-Coulumb theory. More...
 
class  MohrCoulombYieldSurface
 This class defines a yield surface according to Von-Mises theory. More...
 
class  RankineYieldSurface
 This class defines a yield surface according to Rankine theory. More...
 
class  SimoJuYieldSurface
 Short class definition. More...
 
class  TrescaYieldSurface
 This class defines a yield surface according to Tresca theory. More...
 
class  VonMisesYieldSurface
 This class defines a yield surface according to Von-Mises theory. More...
 
class  ParallelRuleOfMixturesLaw
 This law defines a parallel rule of mixture (classic law of mixture) More...
 
class  SerialParallelRuleOfMixturesLaw
 This CL implements the serial-parallel rule of mixtures developed by F.Rastellini. More...
 
class  TractionSeparationLaw3D
 This law defines a parallel rule of mixture (classic law of mixture) More...
 
class  HyperElasticIsotropicHenky1D
 
class  HyperElasticIsotropicKirchhoff3D
 This law defines an hyperelastic material according to the Saint-Venant–Kirchhoff formulation for 3D cases. More...
 
class  HyperElasticIsotropicKirchhoffPlaneStrain2D
 This law defines an hyperelastic material according to the Saint-Venant–Kirchhoff formulation for 2D-plane strain cases. More...
 
class  HyperElasticIsotropicKirchhoffPlaneStress2D
 This law defines an hyperelastic material according to the Saint-Venant–Kirchhoff formulation for 2D-plane stress cases. More...
 
class  HyperElasticIsotropicNeoHookean3D
 This law defines an hyperelastic material according to the NeoHookean formulation for 3D cases. More...
 
class  HyperElasticIsotropicNeoHookeanPlaneStrain2D
 This law defines an hyperelastic material according to the NeoHookean formulation for 2D-plane strain cases. More...
 
class  HyperElasticIsotropicOgden1D
 
class  HyperElasticIsotropicQuasiIncompressibleIshochoricNeoHookean3D
 This law defines an hyperelastic material according to the NeoHookean formulation for 3D cases assuming quasi incompressibility. More...
 
class  HyperElasticSimoTaylorNeoHookean3D
 This law defines a Neo-Hookean hyperelastic material with monotonic behavior for 3D problems. More...
 
class  HyperElasticSimoTaylorNeoHookeanPlaneStrain2D
 This law defines a Neo-Hookean hyperelastic material with monotonic behavior for plane strain problems. More...
 
class  FiniteStrainIsotropicPlasticityFactory
 Dummy class to register, only implements create() More...
 
class  FiniteStrainKinematicPlasticityFactory
 Dummy class to register, only implements create() More...
 
class  GenericFiniteStrainIsotropicPlasticity
 This class is the base class which define all the constitutive laws for plasticity in strain framework. More...
 
class  GenericFiniteStrainKinematicPlasticity
 This class is the base class which define all the constitutive laws for plasticity in strain framework. More...
 
class  GenericAnisotropic3DLaw
 This CL takes into account the material anisotropy in terms of young modulus, poisson ratio, orientation and strengths. More...
 
class  DamageDPlusDMinusMasonry3DLaw
 
class  GenericSmallStrainDplusDminusDamage
 This class is the base class which define all the constitutive laws for damage in small deformation. More...
 
class  GenericSmallStrainIsotropicDamage
 This class is the base class which define all the constitutive laws for damage in small deformation. More...
 
class  GenericSmallStrainIsotropicDamagePlaneStress
 This class is the base class which define all the constitutive laws for damage in plane stress small deformation. More...
 
class  GenericSmallStrainOrthotropicDamage
 This class defines an small strain orthotropic damage model developed by Cervera et. al in "Appraisement of planar, bending and twisting cracks in 3D with isotropic and orthotropic damage models" International Journal of Fracture. More...
 
class  DamageDPlusDMinusMasonry2DLaw
 
class  SmallStrainIsotropicDamage3D
 Defines a damage with hardening constitutive law in 3D. More...
 
class  SmallStrainIsotropicDamageFactory
 Dummy class to register, only implements create() More...
 
class  SmallStrainIsotropicDamageImplex3D
 Damage with hardening constitutive law in 3D, using Implex integration scheme (see J Oliver et al, 2008, An implicit/explicit integration scheme to increase computability of non-linear material and contact/friction problems) More...
 
class  SmallStrainIsotropicDamagePlaneStrain2D
 
class  SmallStrainIsotropicDamageTractionOnly3D
 
class  SmallStrainIsotropicDamageTractionOnlyImplex3D
 Traction-only damage with hardening constitutive law in 3D, using Implex integration scheme (see J Oliver et al, 2008, An implicit/explicit integration scheme to increase computability of non-linear material and contact/friction problems) More...
 
class  GenericSmallStrainHighCycleFatigueLaw
 This class is the base class which defines the constitutive law used for high cycle fatigue (HCF) in small deformation. More...
 
class  ElasticIsotropicPlaneStressUncoupledShear
 Defines a elastic constitutive law in 2D under plane stress in addition the shear modulus is independent from the Young modulus as well as the poisson ratio. More...
 
class  LinearElasticOrthotropic2DLaw
 
class  MultiLinearElastic1DLaw
 
class  MultiLinearIsotropicPlaneStress2D
 
class  WrinklingLinear2DLaw
 This law defines a wrinkling modification for any linear 2D claw. More...
 
class  AssociativePlasticDamageModel
 This law defines a parallel rule of mixture (classic law of mixture) More...
 
class  GenericSmallStrainPlasticDamageModel
 This class is the base class which define the Plastic Damage model developed by Luccioni B. and Oller S. More...
 
class  GenericSmallStrainIsotropicPlasticity
 This class is the base class which define all the constitutive laws for plasticity in small deformation. More...
 
class  GenericSmallStrainKinematicPlasticity
 This class is the base class which define all the constitutive laws for kinematic plasticity in small deformation. More...
 
class  PlasticityIsotropicKinematicJ2
 Defines a Simo J2 plasticity CL with Isotropic & Kinematic Hardening in 3D. More...
 
class  SmallStrainIsotropicPlasticityFactory
 Dummy class to register, only implements create() More...
 
class  SmallStrainJ2Plasticity3D
 
class  SmallStrainJ2PlasticityPlaneStrain2D
 
class  SmallStrainKinematicPlasticityFactory
 Dummy class to register, only implements create() More...
 
class  TrussPlasticityConstitutiveLaw
 
class  GenericSmallStrainViscoplasticity3D
 
class  ViscousGeneralizedKelvin
 This is a constitutive law that reproduces the behaviour of viscous Kelvin material. More...
 
class  ViscousGeneralizedMaxwell
 This is a viscous law using Maxwell formulation. More...
 
class  ThermalDruckerPragerYieldSurface
 This class defines a yield surface according to Drucker-Prager theory. More...
 
class  ThermalModifiedMohrCoulombYieldSurface
 This class defines a yield surface according to Modified Mohr-Coulumb theory. More...
 
class  ThermalMohrCoulombYieldSurface
 This class defines a yield surface according to Von-Mises theory. More...
 
class  ThermalRankineYieldSurface
 
class  ThermalSimoJuYieldSurface
 This class defines a yield surface according to Simo-Ju theory. More...
 
class  ThermalTrescaYieldSurface
 
class  ThermalVonMisesYieldSurface
 This class defines a yield surface according to Von-Mises theory. More...
 
class  GenericSmallStrainThermalIsotropicDamage
 This class derives from the Isotropic damage CL and adds thermal effects (material properties affectation and internal variables) More...
 
class  GenericSmallStrainThermalIsotropicDamagePlaneStress
 
class  ThermalElasticIsotropic3D
 This class defines a Thermo dependant CL, including the addition of thermal expansion strains. More...
 
class  ThermalLinearPlaneStrain
 This class defines a Thermo dependant CL, including the addition of thermal expansion strains. More...
 
class  ThermalLinearPlaneStress
 This class defines a Thermo dependant CL, including the addition of thermal expansion strains. More...
 
class  AdvanceInTimeHighCycleFatigueProcess
 This class determines the advance in time to be performed for a regular cyclic load for the high cycle fatigue CL. More...
 
class  ElementDeactivationProcess
 This class process deactivates elements according to a certain variable threshold We currently suport double and Vector variable types. More...
 
class  SetAutomatedInitialDamageProcess
 This class automotes the creation of the DAMAGE variable using tables imported from csv files. More...
 
class  AdvancedConstitutiveLawUtilities
 This class includes several utilities necessaries for the computation of the constitutive law. More...
 
class  AutomaticDifferentiationTangentUtilities
 
class  TangentOperatorCalculatorUtility
 An algorithm that derives numerically the constitutive tangent tensor at one GP. More...
 
class  KratosConstitutiveModelsApplication
 Short class definition. More...
 
class  Constitutive3DLaw
 
class  LargeStrain3DLaw
 
class  LargeStrainAxisymmetric2DLaw
 Short class definition. More...
 
class  LargeStrainPlaneStrain2DLaw
 Short class definition. More...
 
class  SmallStrain3DLaw
 
class  SmallStrainAxisymmetric2DLaw
 Short class definition. More...
 
class  SmallStrainOrthotropic3DLaw
 Short class definition. More...
 
class  SmallStrainPlaneStrain2DLaw
 Short class definition. More...
 
class  SmallStrainPlaneStress2DLaw
 Short class definition. More...
 
class  NewtonianFluid3DLaw
 
class  NewtonianFluidPlaneStrain2DLaw
 Short class definition. More...
 
class  StrainRate3DLaw
 
class  StrainRatePlaneStrain2DLaw
 Short class definition. More...
 
class  ConstitutiveModel
 Short class definition. More...
 
class  ConstitutiveModelData
 Short class definition. More...
 
class  BorjaModel
 Short class definition. More...
 
class  HenckyHyperElasticModel
 Short class definition. More...
 
class  HyperElasticModel
 Short class definition. More...
 
class  HypoElasticModel
 Short class definition. More...
 
class  IncompressibleHypoElasticModel
 Short class definition. More...
 
class  IncompressibleNeoHookeanModel
 Short class definition. More...
 
class  IsochoricHypoElasticModel
 Short class definition. More...
 
class  IsochoricMooneyRivlinModel
 Short class definition. More...
 
class  IsochoricNeoHookeanLnJSquaredModel
 Short class definition. More...
 
class  IsochoricNeoHookeanModel
 Short class definition. More...
 
class  IsochoricOgdenModel
 Short class definition. More...
 
class  LinearElasticModel
 Short class definition. More...
 
class  MooneyRivlinModel
 Short class definition. More...
 
class  NeoHookeanJ_1SquaredModel
 Short class definition. More...
 
class  NeoHookeanLnJSquaredModel
 Short class definition. More...
 
class  NeoHookeanModel
 Short class definition. More...
 
class  OgdenModel
 Short class definition. More...
 
class  SaintVenantKirchhoffModel
 Short class definition. More...
 
class  TamagniniModel
 Short class definition. More...
 
class  YeohModel
 Short class definition. More...
 
class  BakerJohnsonCookJ2ThermoPlasticityModel
 Short class definition. More...
 
class  CamClayModel
 Short class definition. More...
 
class  DamageModel
 Short class definition. More...
 
class  GensNovaModel
 Short class definition. More...
 
class  BakerJohnsonCookThermalHardeningRule
 Short class definition. More...
 
class  CamClayHardeningRule
 Short class definition. More...
 
class  ExponentialDamageHardeningRule
 Short class definition. More...
 
class  GensNovaHardeningRule
 Short class definition. More...
 
class  HardeningRule
 Short class definition. More...
 
class  JohnsonCookThermalHardeningRule
 Short class definition. More...
 
class  ModifiedExponentialDamageHardeningRule
 Short class definition. More...
 
class  SimoExponentialHardeningRule
 Short class definition. More...
 
class  SimoExponentialThermalHardeningRule
 Short class definition. More...
 
class  SimoLinearHardeningRule
 Short class definition. More...
 
class  JohnsonCookJ2ThermoPlasticityModel
 Short class definition. More...
 
class  LinearAssociativePlasticityModel
 Short class definition. More...
 
class  NonAssociativePlasticityModel
 Short class definition. More...
 
class  NonLinearAssociativePlasticityModel
 Short class definition. More...
 
class  NonLinearRateDependentPlasticityModel
 Short class definition. More...
 
class  NonlocalCamClayModel
 Short class definition. More...
 
class  NonlocalV2GensNovaModel
 Short class definition. More...
 
class  PlasticityModel
 Short class definition. More...
 
class  SimoJ2PlasticityModel
 Short class definition. More...
 
class  SimoJ2ThermoPlasticityModel
 Short class definition. More...
 
class  SimoJuExponentialDamageModel
 Short class definition. More...
 
class  SimoJuModifiedExponentialDamageModel
 Short class definition. More...
 
class  StructuredSoilModel
 Short class definition. More...
 
class  V2GensNovaModel
 Short class definition. More...
 
class  VonMisesLinearElasticPlasticityModel
 Short class definition. More...
 
class  VonMisesNeoHookeanPlasticityModel
 Short class definition. More...
 
class  GensNovaYieldSurface
 Short class definition. More...
 
class  MisesHuberThermalYieldSurface
 Short class definition. More...
 
class  MisesHuberYieldSurface
 Short class definition. More...
 
class  ModifiedCamClayYieldSurface
 Short class definition. More...
 
class  ModifiedMisesYieldSurface
 Short class definition. More...
 
class  YieldSurface
 Short class definition. More...
 
class  NonLocalPlasticityProcess
 
class  PythonOutfittedConstitutiveLaw
 
class  ConstitutiveModelUtilities
 Short class definition. More...
 
class  PropertiesLayout
 PropertiesLayout. More...
 
class  ShapeAtDeviatoricPlaneMCCUtility
 
class  StressInvariantsUtilities
 
class  TableKeyVariables
 TableKeyVariables. More...
 
class  KratosContactMechanicsApplication
 Short class definition. More...
 
class  CircleBoundingBox
 Short class definition. More...
 
class  CompoundNosesBoundingBox
 Short class definition. More...
 
class  CylinderBoundingBox
 Short class definition. More...
 
class  PlaneBoundingBox
 Short class definition. More...
 
class  SphereBoundingBox
 Short class definition. More...
 
class  TubeBoundingBox
 Short class definition. More...
 
class  BeamPointPressureCondition
 Short class definition. More...
 
class  BeamPointRigidContactCondition
 Beam Point Rigid Contact Condition for 3D and 2D geometries. (base class) More...
 
class  BeamPointRigidContactLM3DCondition
 Short class definition. More...
 
class  BeamPointRigidContactPenalty3DCondition
 Short class definition. More...
 
class  AxisymContactDomainLM2DCondition
 
class  AxisymContactDomainPenalty2DCondition
 
class  ContactDomainCondition
 
class  ContactDomainLM2DCondition
 
class  ContactDomainLM3DCondition
 
class  ContactDomainPenalty2DCondition
 
class  HydraulicAxisymRigidContactPenalty2DCondition
 Short class definition. More...
 
class  HydraulicRigidContactPenalty3DCondition
 Short class definition. More...
 
class  RigidBodyPointLinkCondition
 Rigid Body Point Rigid Contact Condition for 3D and 2D geometries. (base class) More...
 
class  RigidBodyPointLinkSegregatedVCondition
 Rigid Body Point Rigid Contact Condition for 3D and 2D geometries. (base class) More...
 
class  AxisymPointRigidContactPenalty2DCondition
 Short class definition. More...
 
class  EPAxisymPointRigidContactPenalty2DCondition
 Short class definition. More...
 
class  EPPointRigidContactPenalty2DCondition
 Short class definition. More...
 
class  EPPointRigidContactPenalty3DCondition
 Short class definition. More...
 
class  EPPointRigidContactPenaltywP3DCondition
 
class  PointRigidContactCondition
 Point Rigid Contact Condition for 3D and 2D geometries. (base class) More...
 
class  PointRigidContactPenalty2DCondition
 Short class definition. More...
 
class  PointRigidContactPenalty3DCondition
 Short class definition. More...
 
class  RigidBodyPointRigidContactCondition
 Rigid Body Point Rigid Contact Condition for 3D and 2D geometries. (base class) More...
 
class  AxisymThermalContactDomainPenalty2DCondition
 
class  ThermalContactDomainCondition
 
class  ThermalContactDomainPenalty2DCondition
 
class  RigidBodyElement
 Rigid Body Element for 3D space dimension. More...
 
class  RigidBodySegregatedVElement
 Rigid Body Segregated V Element for 3D space dimension. More...
 
class  TranslatoryRigidBodyElement
 Rigid Body Element for 3D space dimension. More...
 
class  TranslatoryRigidBodySegregatedVElement
 Rigid Body Segregated V Element for 3D space dimension. More...
 
class  CoulombAdhesionFrictionLaw
 Short class definition. More...
 
class  FrictionLaw
 Short class definition. More...
 
class  HardeningCoulombFrictionLaw
 Short class definition. More...
 
class  ContactDomain2DMesher
 Short class definition. More...
 
class  ContactDomain3DMesher
 Short class definition. More...
 
class  BuildContactModelPartProcess
 Short class definition. More...
 
class  ClearContactConditionsMesherProcess
 Short class definition. More...
 
class  ClearPointContactConditionsProcess
 Short class definition. More...
 
class  GenerateNewContactConditionsMesherProcess
 Short class definition. More...
 
class  HMParametricWallContactSearchProcess
 The base class for all processes in Kratos. More...
 
class  ParametricWallContactSearchProcess
 The base class for all processes in Kratos. More...
 
class  SettleContactModelStructureProcess
 Short class definition. More...
 
class  ResidualBasedBossakDisplacementRotationScheme
 
class  ContactDomainUtilities
 Short class definition. More...
 
class  RigidBodyElementCreationUtility
 Rigid body element build processes in Kratos. More...
 
class  RigidBodyUtilities
 Short class definition. More...
 
class  SplineCurveUtilities
 Short class definition. More...
 
class  KratosContactStructuralMechanicsApplication
 This application features Elements, Conditions, Constitutive laws and Utilities for structural analysis problems with contact constraints. More...
 
class  AugmentedLagrangianMethodFrictionalMortarContactAxisymCondition
 AugmentedLagrangianMethodFrictionalMortarContactAxisymCondition. More...
 
class  AugmentedLagrangianMethodFrictionalMortarContactCondition
 AugmentedLagrangianMethodFrictionalMortarContactCondition. More...
 
class  AugmentedLagrangianMethodFrictionlessComponentsMortarContactCondition
 AugmentedLagrangianMethodFrictionlessComponentsMortarContactCondition. More...
 
class  AugmentedLagrangianMethodFrictionlessMortarContactAxisymCondition
 AugmentedLagrangianMethodFrictionlessMortarContactAxisymCondition. More...
 
class  AugmentedLagrangianMethodFrictionlessMortarContactCondition
 AugmentedLagrangianMethodFrictionlessMortarContactCondition. More...
 
class  MeshTyingMortarCondition
 MeshTyingMortarCondition. More...
 
class  MortarContactCondition
 MortarContactCondition. More...
 
class  MPCMortarContactCondition
 MPCMortarContactCondition. More...
 
class  PairedCondition
 This is a base class for the conditions paired. More...
 
class  PenaltyMethodFrictionalMortarContactAxisymCondition
 PenaltyMethodFrictionalMortarContactAxisymCondition. More...
 
class  PenaltyMethodFrictionalMortarContactCondition
 PenaltyMethodFrictionalMortarContactCondition. More...
 
class  PenaltyMethodFrictionlessMortarContactAxisymCondition
 PenaltyMethodFrictionlessMortarContactAxisymCondition. More...
 
class  PenaltyMethodFrictionlessMortarContactCondition
 PenaltyMethodFrictionlessMortarContactCondition. More...
 
class  CoulombFrictionalLaw
 This class defines the Coulomb frictional laws. More...
 
class  FrictionalLaw
 This class defines the base class for frictional laws. More...
 
class  FrictionalLawWithDerivative
 This class defines the base class for frictional laws with derivative. More...
 
class  TrescaFrictionalLaw
 This class defines the Tresca frictional laws. More...
 
class  MixedULMLinearSolver
 This solver is designed for the solution of mixed U-LM problems (this solver in particular is optimized for dual LM, to avoid the resolution). More...
 
class  ContactMasterSlaveConstraint
 This is a constraint for contact mechanics based in a linear kinematic MPC constriant. More...
 
class  AALMAdaptPenaltyValueProcess
 This process is used in order to adapt the penalty in the ALM formulation. More...
 
class  AdvancedContactSearchProcess
 This utilitiy has as objective to create the contact conditions. More...
 
class  ALMFastInit
 This process initializes the variables related with the ALM. More...
 
class  ALMVariablesCalculationProcess
 This process calculates the variables related with the ALM. More...
 
class  AssignParentElementConditionsProcess
 This process initializes the variables related with the ALM. More...
 
class  BaseContactSearchProcess
 This process has as objective to create the contact conditions. More...
 
class  ComputeDynamicFactorProcess
 This process is used in order to compute the dynamic factor for dynamic problems. More...
 
class  ContactSearchWrapperProcess
 This process is a wrapper for AdvancedContactSearchProcess and SimpleContactSearchProcess. More...
 
class  ContactSPRErrorProcess
 This class is can be used to compute the metrics of the model part with a superconvergent patch recovery (SPR) approach. More...
 
class  FindIntersectedGeometricalObjectsWithOBBContactSearchProcess
 This class is a modification of FindIntersectedGeometricalObjectsWithOBBProcess for contact search. More...
 
class  MasterSlaveProcess
 This process assigns as master/slave the conditions. More...
 
class  MPCContactSearchProcess
 This utilitiy has as objective to create the contact constraints. More...
 
class  MPCContactSearchWrapperProcess
 This process is a wrapper forMPCContactSearchProcess. More...
 
class  NormalCheckProcess
 This process checks the normal. More...
 
class  NormalGapProcess
 This process computes the normal gap. More...
 
class  SimpleContactSearchProcess
 This utilitiy has as objective to create the contact conditions. More...
 
class  ProcessFactoryUtility
 This is a experimental process factory utility. More...
 
class  ContactResidualBasedBlockBuilderAndSolver
 Current class provides an implementation for contact builder and solving operations. More...
 
class  ContactResidualBasedEliminationBuilderAndSolver
 Current class provides an implementation for contact builder and solving operations. (elimination) More...
 
class  ContactResidualBasedEliminationBuilderAndSolverWithConstraints
 Current class provides an implementation for contact builder and solving operations. (elimination) More...
 
class  ALMFrictionalMortarConvergenceCriteria
 Custom convergence criteria for the mortar condition for frictional case. More...
 
class  ALMFrictionlessComponentsMortarConvergenceCriteria
 Custom convergence criteria for the mortar condition for frictionless case with components. More...
 
class  ALMFrictionlessMortarConvergenceCriteria
 Custom convergence criteria for the mortar condition for frictionless case with components. More...
 
class  BaseMortarConvergenceCriteria
 Custom convergence criteria for the mortar condition. More...
 
class  ContactErrorMeshCriteria
 Custom convergence for used to check the convergence in the mesh error. More...
 
class  DisplacementContactCriteria
 Convergence criteria for contact problems. More...
 
class  DisplacementLagrangeMultiplierContactCriteria
 Convergence criteria for contact problems. More...
 
class  DisplacementLagrangeMultiplierFrictionalContactCriteria
 Convergence criteria for contact problems. More...
 
class  DisplacementLagrangeMultiplierMixedContactCriteria
 Convergence criteria for contact problems. More...
 
class  DisplacementLagrangeMultiplierMixedFrictionalContactCriteria
 Convergence criteria for contact problems. More...
 
class  DisplacementLagrangeMultiplierResidualContactCriteria
 Convergence criteria for contact problems This class implements a convergence control based on nodal displacement and lagrange multiplier values. The error is evaluated separately for each of them, and relative and absolute tolerances for both must be specified. More...
 
class  DisplacementLagrangeMultiplierResidualFrictionalContactCriteria
 Convergence criteria for contact problems (only for frictional cases) This class implements a convergence control based on nodal displacement and lagrange multiplier values. The error is evaluated separately for each of them, and relative and absolute tolerances for both must be specified. More...
 
class  DisplacementResidualContactCriteria
 Convergence criteria for contact problems This class implements a convergence control based on nodal displacement (for penalty contact) More...
 
class  MeshTyingMortarConvergenceCriteria
 
class  MortarAndConvergenceCriteria
 Custom AND convergence criteria for the mortar condition. More...
 
class  MPCContactCriteria
 Custom convergence criteria for the contact problem. More...
 
class  PenaltyFrictionalMortarConvergenceCriteria
 Custom convergence criteria for the mortar condition for frictional case. More...
 
class  PenaltyFrictionlessMortarConvergenceCriteria
 Custom convergence criteria for the mortar condition for frictionless case with components. More...
 
class  LineSearchContactStrategy
 A strategy for solving contact problems using a line search method. More...
 
class  ResidualBasedNewtonRaphsonContactStrategy
 Contact Newton Raphson class. More...
 
class  ResidualBasedNewtonRaphsonMPCContactStrategy
 Contact Newton Raphson class. More...
 
class  ContactUtilities
 This class includes some utilities used for contact computations. More...
 
class  DerivativesUtilities
 This utilities are used in order to compute the directional derivatives during mortar contact. More...
 
class  ImplementationDerivativesUtilities
 Auxiliary implementation for DerivativesUtilities. More...
 
class  InterfacePreprocessCondition
 Creates Model Parts containing the interface. More...
 
class  MortarExplicitContributionUtilities
 This namespace includes several utilities necessaries for the computation of the explicit contribution of the mortar conditions. More...
 
class  KratosConvectionDiffusionApplication
 The Convection Diffusion Application contains a series of elements and conditions and the corresponding strategies and solvers within Kratos Multiphysics necesaries in order to simulate a convection-diffusion problem. More...
 
class  AdjointThermalFace
 Heat flux Neumann condition for the ajdoint thermal diffusion problem. More...
 
class  AxisymmetricThermalFace
 Axisymmetric thermal face condition Extension of the base ThermalFace class to be used in axisymmetric problems. More...
 
class  FluxCondition
 A basic Neumann condition for convection-diffusion problems. More...
 
class  ThermalFace
 A basic Neumann condition for convection-diffusion problems. More...
 
class  AdjointDiffusionElement
 Basic element for the ajdoint diffusion problem. More...
 
class  AxisymmetricEulerianConvectionDiffusionElement
 
class  ConvDiff2D
 A stabilized element for solving the convection diffusion equations in 2D. More...
 
class  ConvDiff3D
 Short class definition. More...
 
class  ConvDiffChangeOfPhase2D
 Short class definition. More...
 
class  DConvectionDiffusionExplicit
 This element solves the convection-diffusion equation, stabilized with algebraic subgrid scale or orthogonal subgrid scale. More...
 
class  EmbeddedLaplacianElement
 
class  EulerianConvectionDiffusionElement
 formulation described in https://docs.google.com/document/d/13a_zGLj6xORDuLgoOG5LwHI6BwShvfO166opZ815zLY/edit?usp=sharing More...
 
class  EulerianDiffusionElement
 formulation described in https://docs.google.com/document/d/13a_zGLj6xORDuLgoOG5LwHI6BwShvfO166opZ815zLY/edit?usp=sharing More...
 
class  LaplacianElement
 Short class definition. More...
 
class  MixedLaplacianElement
 Mixed Laplacian formulation element This element implements a mixed Laplacian (scalar - gradient) formulation. More...
 
class  QSConvectionDiffusionExplicit
 This element solves the convection-diffusion equation, stabilized with algebraic subgrid scale or orthogonal subgrid scale. More...
 
class  LocalTemperatureAverageResponseFunction
 
class  ExplicitSolvingStrategyRungeKutta4ConvectionDiffusion
 This strategy adds the orthogonal subgrid projections computation to the base explicit runge kutta 4 integration method. More...
 
class  ResidualBasedConvectionDiffusionStrategy
 This strategy is used to solve convection-diffusion problem. More...
 
class  ResidualBasedConvectionDiffusionStrategyNonLinear
 This strategy is used to solve convection-diffusion problem. More...
 
class  ResidualBasedEulerianConvectionDiffusionStrategy
 This strategy is used to solve convection-diffusion problem. More...
 
class  ResidualBasedSemiEulerianConvectionDiffusionStrategy
 This strategy is used to solve convection-diffusion problem. More...
 
class  BFECCConvection
 
class  BFECCLimiterConvection
 
class  Convection_Particle
 PFEM Particle class. More...
 
class  EmbeddedMLSConstraintProcess
 
class  FaceHeatUtilities
 
class  MoveParticleUtilityScalarTransport
 
class  PureConvectionCrankNUtilities
 
class  PureConvectionUtilities
 
class  KratosCoSimulationApplication
 Short class definition. More...
 
class  CoSimIOConversionUtilities
 Short class definition. More...
 
class  ConversionUtilities
 Short class definition. More...
 
class  FetiDynamicCouplingUtilities
 
class  KratosCSharpWrapperApplication
 This is a custom application for being able to couple C++ code of Kratos with CSharp. More...
 
class  AddedMassCondition
 
class  FreeSurfaceCondition
 
class  InfiniteDomainCondition
 
class  UPCondition
 
class  LinearElastic2DPlaneStrainNodal
 
class  LinearElastic2DPlaneStressNodal
 
class  LinearElastic3DLawNodal
 
class  ThermalLinearElastic2DPlaneStrain
 
class  ThermalLinearElastic2DPlaneStrainNodal
 
class  ThermalLinearElastic2DPlaneStress
 
class  ThermalLinearElastic2DPlaneStressNodal
 
class  ThermalLinearElastic3DLaw
 
class  ThermalLinearElastic3DLawNodal
 
class  ThermalLocalDamage3DLaw
 
class  ThermalLocalDamagePlaneStrain2DLaw
 
class  ThermalLocalDamagePlaneStress2DLaw
 
class  ThermalModifiedMisesNonlocalDamage3DLaw
 
class  ThermalModifiedMisesNonlocalDamagePlaneStrain2DLaw
 
class  ThermalModifiedMisesNonlocalDamagePlaneStress2DLaw
 
class  ThermalNonlocalDamage3DLaw
 
class  ThermalNonlocalDamagePlaneStrain2DLaw
 
class  ThermalNonlocalDamagePlaneStress2DLaw
 
class  ThermalSimoJuLocalDamage3DLaw
 
class  ThermalSimoJuLocalDamagePlaneStrain2DLaw
 
class  ThermalSimoJuLocalDamagePlaneStress2DLaw
 
class  ThermalSimoJuNonlocalDamage3DLaw
 
class  ThermalSimoJuNonlocalDamagePlaneStrain2DLaw
 
class  ThermalSimoJuNonlocalDamagePlaneStress2DLaw
 
class  SmallDisplacementElement
 Small Displacement Element for 3D and 2D geometries. More...
 
class  SmallDisplacementInterfaceElement
 
class  SmallDisplacementThermoMechanicElement
 
class  SolidElement
 Large Displacement Lagrangian Element for 3D and 2D geometries. (base class) More...
 
class  WaveEquationElement
 
class  ApplyComponentTableProcessDam
 
class  DamAddedMassConditionProcess
 
class  DamAzenhaHeatFluxProcess
 
class  DamBofangConditionTemperatureProcess
 
class  DamChemoMechanicalAgingYoungProcess
 
class  DamFixTemperatureConditionProcess
 
class  DamGroutingReferenceTemperatureProcess
 
class  DamHydroConditionLoadProcess
 
class  DamInputTableNodalYoungModulusProcess
 
class  DamNodalReferenceTemperatureProcess
 
class  DamNodalYoungModulusProcess
 
class  DamNoorzaiHeatFluxProcess
 
class  DamRandomFieldsVariableProcess
 
class  DamReservoirConstantTemperatureProcess
 
class  DamReservoirMonitoringTemperatureProcess
 
class  DamTSolAirHeatFluxProcess
 
class  DamTemperaturebyDeviceProcess
 
class  DamUpliftCircularConditionLoadProcess
 
class  DamUpliftConditionLoadProcess
 
class  DamWestergaardConditionLoadProcess
 
class  BossakDisplacementSmoothingScheme
 
class  DamPScheme
 
class  DamUPScheme
 
class  IncrementalUpdateStaticDampedSmoothingScheme
 
class  IncrementalUpdateStaticSmoothingScheme
 
class  ConstructionUtility
 
class  GlobalJointStressUtility
 
class  MappingVariables2DUtilities
 
class  MappingVariables3DUtilities
 
class  StreamlinesOutput3DUtilities
 
class  TransferSelfweightStressUtility
 
class  KratosDamApplication
 
class  SpatialBoundingBox
 Short class definition. More...
 
class  CompositeCondition
 Updated Total Lagrangian element for 2D and 3D geometries. More...
 
class  LaplacianSmoothing
 Short class definition. More...
 
class  Mesher
 Short class definition. More...
 
class  TetrahedralMesh3DMesher
 Short class definition. More...
 
class  TriangularMesh2DMesher
 Short class definition. More...
 
class  BuildModelPartBoundaryProcess
 Short class definition. More...
 
class  ConstantRotationProcess
 
class  ElementalNeighboursSearchProcess
 Short class definition. More...
 
class  GenerateNewConditionsMesherProcess
 Short class definition. More...
 
class  GenerateNewElementsMesherProcess
 Short class definition. More...
 
class  GenerateNewNodesMesherProcess
 Refine Mesh Elements Process 2D and 3D. More...
 
class  MesherProcess
 The base class for processes passed to the solution scheme. More...
 
class  ModelVolumeCalculationProcess
 
class  NodalNeighboursSearchProcess
 Short class definition. More...
 
class  PrintMeshOutputMesherProcess
 
class  RefineConditionsMesherProcess
 Refine Mesh Boundary Process. More...
 
class  RefineElementsInEdgesMesherProcess
 Refine Mesh Elements Process 2D and 3D. More...
 
class  RefineElementsOnSizeMesherProcess
 Refine Mesh Elements Process 2D and 3D. More...
 
class  RefineElementsOnThresholdMesherProcess
 Refine Mesh Elements Process 2D and 3D. More...
 
class  RemoveNodesMesherProcess
 Remove Mesh Nodes Process for 2D and 3D cases. More...
 
class  SelectElementsMesherProcess
 Refine Mesh Elements Process 2D and 3D. More...
 
class  SettleModelStructureProcess
 Short class definition. More...
 
class  TransferBetweenModelPartsProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  BoundaryNormalsCalculationUtilities
 
class  MeshDataTransferUtilities
 Short class definition. More...
 
class  MeshErrorCalculationUtilities
 Short class definition. More...
 
class  MesherUtilities
 Short class definition. More...
 
class  KratosDelaunayMeshingApplication
 Short class definition. More...
 
class  AnalyticRigidFace3D
 
class  DEMWall
 
class  MAPcond
 
class  RigidEdge2D
 
class  RigidFace3D
 
class  SolidFace3D
 
class  DEMBeamConstitutiveLaw
 
class  DEM_compound_constitutive_law
 
class  DEM_compound_constitutive_law_for_PBM
 
class  DemContact
 
class  DEMContinuumConstitutiveLaw
 
class  DEM_D_Bentonite_Colloid
 
class  DEM_D_Conical_damage
 
class  DEM_D_DMT_Cohesive_Law
 
class  DEM_D_Hertz_confined
 
class  DEM_D_Hertz_viscous_Coulomb2D
 
class  DEM_D_Hertz_viscous_Coulomb
 
class  DEM_D_Hertz_viscous_Coulomb_Nestle
 
class  DEM_D_JKR_Cohesive_Law
 
class  DEM_D_Linear_classic
 
class  DEM_D_Linear_confined
 
class  DEM_D_Linear_Custom_Constants
 
class  DEM_D_Linear_HighStiffness_2D
 
class  DEM_D_Linear_HighStiffness
 
class  DEM_D_Linear_viscous_Coulomb2D
 
class  DEM_D_Linear_viscous_Coulomb
 
class  DEM_D_Quadratic
 
class  DEM_D_Stress_Dependent_Cohesive
 
class  DEM_D_void
 
class  DEM_Dempack2D
 
class  DEM_Dempack2D_dev
 
class  DEM_Dempack
 
class  DEM_Dempack_dev
 
class  DEM_Dempack_torque
 
class  DEMDiscontinuumConstitutiveLaw
 
class  DEM_ExponentialHC
 
class  DEM_KDEM2D
 
class  DEM_KDEM_CamClay
 
class  DEM_KDEM
 
class  DEM_KDEMFabric2D
 
class  DEM_KDEMFabric
 
class  DEM_KDEM_Fissured_Rock_CL
 
class  DEM_KDEM_Mohr_Coulomb
 
class  DEM_KDEM_Rankine
 
class  DEM_KDEM_soft_torque
 
class  DEM_KDEM_soft_torque_with_noise
 
class  DEM_KDEM_with_damage
 
class  DEM_KDEM_with_damage_parallel_bond_2D
 
class  DEM_KDEM_with_damage_parallel_bond_capped
 
class  DEM_KDEM_with_damage_parallel_bond
 
class  DEM_KDEM_with_damage_parallel_bond_Hertz_2D
 
class  DEM_KDEM_with_damage_parallel_bond_Hertz
 
class  DEM_parallel_bond
 
class  DEM_parallel_bond_for_membrane
 
class  DEMRollingFrictionModel
 
class  DEMRollingFrictionModelBounded
 
class  DEMRollingFrictionModelConstantTorque
 
class  DEMRollingFrictionModelViscousTorque
 
class  DEM_smooth_joint
 
class  AnalyticRigidBodyElement
 
class  AnalyticSphericParticle
 
class  BeamParticle
 
class  BondingSphericContinuumParticle
 
class  Cluster3D
 
class  ContactInfoSphericParticle
 
class  SingleSphereCluster3D
 
class  CylinderContinuumParticle
 
class  CylinderParticle
 
class  DiscreteElement
 
class  IceContinuumParticle
 
class  NanoParticle
 
class  ParticleContactElement
 
class  PolyhedronSkinSphericParticle
 
class  RigidBodyElement3D
 
class  ShipElement3D
 
class  SphericContinuumParticle
 
class  SphericParticle
 
class  ApplyForcesAndMomentsProcess
 Auxiliary process to apply forces and moments to particles. More...
 
class  ApplyForcesAndMomentsToWallsProcess
 Auxiliary process to apply forces and moments to walls. More...
 
class  ApplyKinematicConstraintsProcess
 Auxiliary process to apply forces and moments to particles. More...
 
class  ApplyKinematicConstraintsToWallsProcess
 Auxiliary process to apply forces and moments to particles. More...
 
class  AutomaticDTProcess
 
class  ControlModule2DProcess
 
class  BinsObjectDynamicPeriodic
 Short class definition. More...
 
class  SubBinAxisPeriodic
 TOOLS UTILS ///. More...
 
class  SearchStructurePeriodic
 
class  DEMIntegrationScheme
 
class  ForwardEulerScheme
 
class  GluedToWallScheme
 
class  QuaternionIntegrationScheme
 
class  RungeKuttaScheme
 
class  SymplecticEulerScheme
 
class  TaylorScheme
 
class  VelocityVerletScheme
 
class  ContinuumExplicitSolverStrategy
 
class  ExplicitSolverSettings
 
class  ExplicitSolverStrategy
 
class  IterativeSolverStrategy
 
class  VelocityVerletSolverStrategy
 
class  AnalyticFaceWatcher
 
class  AnalyticModelPartFiller
 
class  AnalyticParticleWatcher
 
class  AnalyticWatcher
 
class  ParticlesHistoryWatcher
 
class  AuxiliaryUtilities
 
class  SphericElementGlobalPhysicsCalculator
 
class  ClusterInformation
 
class  ParticleCreatorDestructor
 
class  DEM_FEM_Search
 Short class definition. More...
 
class  DEMFEMUtilities
 
class  DiscreteParticleConfigure
 
class  DiscreteRandomVariable
 
class  ExcavatorUtility
 
class  DEM_Force_Based_Inlet
 
class  GeometricalConfigure
 
class  DEM_Inlet
 
class  MoveMeshUtility
 This utilitiy moves the nodes of a dem wall used especially in the fem-dem coupling. More...
 
class  MultiaxialControlModuleGeneralized2DUtilities
 
class  OMP_DEMSearch
 Short class definition. More...
 
class  ParallelBondUtilities
 
class  Particle_Data
 
class  PiecewiseLinearRandomVariable
 
class  PostUtilities
 
class  PreUtilities
 
class  PropertiesProxy
 
class  PropertiesProxiesManager
 
class  RandomVariable
 
class  ReorderConsecutiveFromGivenIdsModelPartIO
 
class  RigidFaceGeometricalObjectConfigure
 
class  DemSearchUtilities
 
class  StationarityChecker
 
class  KratosDEMApplication
 
class  DEMFlags
 
class  LineLoadFromDEMCondition2D
 
class  SurfaceLoadFromDEMCondition3D
 
class  ControlModuleProcess
 
class  ComputeDEMFaceLoadUtility
 
class  ControlModuleFemDem2DUtilities
 
class  ControlModuleFemDemUtilities
 
class  DemStructuresCouplingUtilities
 
class  EffectiveStressesCommunicatorUtility
 
class  InterpolateStructuralSolutionForDEM
 
class  MultiaxialControlModuleFEMDEMGeneralized2DUtilities
 
class  PermeabilityTensorCommunicatorUtility
 
class  PorePressureCommunicatorUtility
 
class  PostProcessUtilities
 
class  SandProductionUtilities
 
class  StressFailureCheckUtilities
 Note: For the moment this only works for cylindrical probes with its axis oriented in Z direction. More...
 
class  KratosDemStructuresCouplingApplication
 
class  DemStructuresCouplingFlags
 
class  DropletDynamicsElement
 
class  KratosDropletDynamicsApplication
 Short class definition. More...
 
class  CalculateDivergenceProcess
 Process to compute divergence. More...
 
class  MetricDivergenceFreeProcess
 This class is can be used to compute the metrics of the model part with different strategies, exploting the divergence. The developed strategies are: mean distribution strategy: this strategy builds a metric which tries to uniformly spread the refinement indicator in the whole domain maximum strategy: this strategy build a metric which aims at refining only if the refinement indicator belong to the interval [coefficient*max(refinement indicator),max(refinement indicator)]. More...
 
class  WeightedDivergenceCalculationProcess
 Process to compute element time average of the divergence. More...
 
class  DragAndMomentUtilities
 Auxiliary utility to compute the drag force and the moment around a given point. More...
 
class  KratosExaquteSandboxApplication
 Short class definition. More...
 
class  ElasticIsotropic3DFEMDEM
 
class  HyperElasticIsotropicNeoHookean3DFEMDEM
 This law defines an hyperelastic material according to the NeoHookean formulation for 3D cases. More...
 
class  HyperElasticIsotropicNeoHookeanPlaneStrain2DFEMDEM
 This law defines an hyperelastic material according to the NeoHookean formulation for 2D-plane strain cases. More...
 
class  LinearPlaneStrainFEMDEM
 This class defines a small deformation linear elastic constitutive model for plane strain cases. More...
 
class  LinearPlaneStressFEMDEM
 This class defines a small deformation linear elastic constitutive model for plane stress cases. More...
 
class  BaseSolidElement
 This is base class used to define the solid elements. More...
 
class  GenericSmallStrainFemDemElement
 Small Displacement element for the 2D and 3D cases. More...
 
class  GenericTotalLagrangianFemDemElement
 Total Lagrangian element for 2D and 3D geometries. More...
 
class  GenericTotalLagrangianMixturesFemDemElement
 Total Lagrangian element taking into account a Classical Rule Of Mixtures and j2-plasticity for the fiber. See Computational Methods for Plasticity - EA de Souza Neto, D Peric and DRJ Owen. More...
 
class  ApplyComponentTableProcess
 
class  ApplyDoubleTableProcess
 
class  AssignPressureIdProcess
 
class  AssignVectorFieldToEntitiesProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  AssignVectorVariableToConditionsProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  ComputeInitialVolumeProcess
 Computes the initial volume of the blast circle and assigns it to the nodes. More...
 
class  ExpandWetNodesProcess
 Assigns the pressure Id to the nodes of the elements that are going to be removed. More...
 
class  ExtendPressureConditionProcess
 Creates the new presure line loads after removing some elements. More...
 
class  FixFreeVelocityOnNodesProcess
 
class  FixScalarDofProcess
 The base class for fixing scalar variable Dof or array_1d component Dof processes in Kratos. More...
 
class  FreeScalarDofProcess
 The base class for freeing scalar variable Dof or array_1d component Dof processes in Kratos. More...
 
class  GenerateDemProcess
 
class  GenerateInitialSkinDEMProcess
 
class  RegeneratePfemPressureConditionsProcess
 Regenerates the pressure conditions for the PFEM coupling. More...
 
class  RemoveAloneDEMElementsProcess
 
class  TransferEntitiesBetweenModelPartsProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  TransferNodalForcesToFem
 
class  UpdateDemKinematicsProcess
 
class  UpdateFlagNoRemeshFemDemBoundaryProcess
 
class  UpdatePressureValuePfemConditionsProcess
 Assigns the pressure value according to the nodal PRESSURE at this time step. More...
 
class  UpdatePressureVolumeProcess
 updates the volume according to a pressure load More...
 
class  FemDemResidualCriteria
 This is a convergence criteria that employes the residual as criteria. More...
 
class  HexahedraNewtonRaphsonStrategy
 This is the base Newton Raphson strategy. More...
 
class  ResidualBasedDEMCoupledNewtonRaphsonStrategy
 This is the base Newton Raphson strategy coupled with the DEM strategy. More...
 
class  AitkenRelaxationFEMDEMUtility
 Aitken relaxation technique for FSI PFEM-FEM-DEM coupling. More...
 
class  ConstitutiveLawUtilities
 This class includes several utilities necessaries for the computation of the constitutive law. More...
 
class  FEMDEMCouplingUtilities
 This class includes several utilities necessaries for the coupling between the FEM and the DEM. More...
 
class  RenumberingNodesUtility
 
class  KratosFemToDemApplication
 
class  AdjointMonolithicWallCondition
 
class  EmbeddedAusasNavierStokesWallCondition
 Implements a wall condition for the Navier-Stokes monolithic formulation. More...
 
class  FSGeneralizedWallCondition
 Implements a generalized wall model accounting for pressure gradients. More...
 
class  FSPeriodicCondition
 Condition used to assign periodic boundary conditions when using a fractional step fluid solver. More...
 
class  FSWernerWengleWallCondition
 Implements a power-law wall model. More...
 
class  MonolithicWallCondition
 Implements a wall condition for the monolithic formulation. More...
 
class  NavierStokesWallCondition
 Implements a wall condition for the Navier-Stokes (and Stokes) monolithic formulations This condition is intended to be used in combination with Navier-Stokes (or Stokes) monolithic formulations. It supports the Neumann BC contribution as well as the addition of a wall law contribution through the TWallModel template argument. Such TWallModel must be a class implementing the wall model RHS and LHS Gauss point contributions (as example see @NavierSlipWallLaw). Current condition also has optional features that help numerical stability such as the outlet inflow energy correction or the spurious tangential velocity correction for pure slip boundaries. More...
 
class  StokesWallCondition
 Implements a wall condition for the monolithic stokes formulation - based on BDF2. More...
 
class  TwoFluidNavierStokesWallCondition
 Implements a wall condition for the Navier-Stokes monolithic formulation. More...
 
class  WallCondition
 Implements a wall condition for the monolithic formulation. More...
 
class  WallConditionDiscontinuous
 Implements a wall condition for the monolithic formulation. More...
 
class  LinearLogWallLaw
 Linear-log law LHS and RHS contribution implementation This class implements the LHS and RHS Gauss point contributions of the linear-log wall model This class should be used in combination with an incompressible Navier-Stokes (or Stokes) condition implementing the remaining terms (see @NavierStokesWallCondition). More...
 
class  NavierSlipWallLaw
 Navier-slip law LHS and RHS contribution implementation This class implements the LHS and RHS contributions of the Navier-slip wall model This class should be used in combination with an incompressible Navier-Stokes (or Stokes) condition implementing the remaining terms (see @NavierStokesWallCondition). More information about can be found in https://onlinelibrary.wiley.com/doi/abs/10.1002/fld.663. More...
 
class  Bingham3DLaw
 
class  Euler2DLaw
 
class  Euler3DLaw
 
class  FluidConstitutiveLaw
 This class contains the common infrastructure for fluid constitutive laws. More...
 
class  HerschelBulkley3DLaw
 
class  Newtonian2DLaw
 
class  Newtonian3DLaw
 
class  NewtonianTemperatureDependent2DLaw
 
class  NewtonianTemperatureDependent3DLaw
 
class  NewtonianTwoFluid2DLaw
 
class  NewtonianTwoFluid3DLaw
 
class  AlternativeDVMSDEMCoupled
 
class  AlternativeQSVMSDEMCoupled
 
class  AxisymmetricNavierStokes
 
class  BinghamFluid
 
class  CompressibleNavierStokesExplicit
 Compressible Navier-Stokes explicit element This element implements a compressible Navier-Stokes explicit formulation. The formulation is written in conservative form so the element unknowns are the DENSITY, MOMENTUM and TOTAL_ENERGY variables. This element is intended to work with the Kratos explicit DOF based strategy. Hence, the explicit residual is written in the corresponding REACTION variables. More...
 
class  DVMS
 
class  DVMSDEMCoupled
 
class  AxisymmetricNavierStokesData
 
class  ZeroDerivatives
 This provides zero derivatives for given any variable. More...
 
class  SubAssembly
 Assembles sub-vectors to element vectors and matrices. More...
 
class  CalculationContainerTraits
 This is traits clas sto hold combined data containers and calculation containers. More...
 
class  QSVMSAdjointElementData
 Traits class to hold QSVMS adjoint element data. More...
 
class  QSVMSDerivativeUtilities
 These are helper classes to define derivatives of coefficients of Navier-Stokes. More...
 
class  QSVMSResidualDerivatives
 Computes the QSVMS residual derivatives. More...
 
class  DistanceSmoothingElement
 
class  DPGVMS
 
class  DynamicVMS
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  EmbeddedAusasNavierStokes
 
class  EmbeddedFluidElement
 
class  EmbeddedFluidElementDiscontinuous
 
class  EmbeddedNavierStokes
 
class  FIC
 
class  FluidAdjointElement
 
class  FluidElement
 Large Displacement Lagrangian Element for 3D and 2D geometries. (base class) More...
 
class  FractionalStep
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  FractionalStepDiscontinuous
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  HerschelBulkleyFluid
 
class  NavierStokes
 
class  QSVMS
 
class  QSVMSDEMCoupled
 
class  SpalartAllmaras
 Short class definition. More...
 
class  StationaryStokes
 GLS-stabilized element for the solution of the stationary Stokes problem. More...
 
class  Stokes3D
 
class  Stokes3DTwoFluid
 
class  SymbolicStokes
 
class  TwoFluidNavierStokes
 
class  TwoFluidNavierStokesAlphaMethod
 
class  TwoFluidVMS
 
class  TwoFluidVMSLinearizedDarcy
 Version of TwoFluidVMS that treats the Darcy term explicitly. More...
 
class  VMS
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  VMSAdjointElement
 An adjoint element for discrete shape sensitivity of VMS fluid element. More...
 
class  WeaklyCompressibleNavierStokes
 
class  ApplyCompressibleNavierStokesBoundaryConditionsProcess
 This process applies diferent boundary conditions accoring to the mach regime. Parameters: More...
 
class  WindkesselModel
 An impelementation of the Windkessel model for boundary condition of incompressible flows. More...
 
class  BoussinesqForceProcess
 Auxiliary process to set Boussinesq buoyancy forces in variable temperature flows. More...
 
class  CalulateLevelsetConsistentNodalGradientProcess
 Utility to calculate the nodal gradient separately for the positive and negative sides of the zero level-set function (interface) More...
 
class  ComputePressureCoefficientProcess
 This process computes the pressure coefficient as a function of reference fluid properties. More...
 
class  ComputeYPlusProcess
 
class  DistanceModificationProcess
 
class  DistanceSmoothingProcess
 
class  EmbeddedNodesInitializationProcess
 
class  EmbeddedPostprocessProcess
 Utility to filter the embedded velocity and pressure values. More...
 
class  EmbeddedSkinVisualizationProcess
 This process saves the intersected elements in a different model part for its visualization. More...
 
class  IntegrationPointStatisticsProcess
 Helper process to record statistics on the integration points of the mesh. More...
 
class  MassConservationCheckProcess
 
class  ShockCapturingEntropyViscosityProcess
 
class  ShockCapturingPhysicsBasedProcess
 
class  SpalartAllmarasTurbulenceModel
 An impelementation of the Spalart-Allmaras turbulence model for incompressible flows. More...
 
class  StokesInitializationProcess
 A process to provide initial values for Navier-Stokes problems. More...
 
class  TwoFluidsInletProcess
 
class  PyDragResponseFunction
 
class  DragResponseFunction
 A response function for drag. More...
 
class  VelocityPressureNormSquareResponseFunction
 A response function for norm square calculation. More...
 
class  ResidualBasedBlockBuilderAndSolverPeriodic
 
class  BDF2TurbulentScheme
 A scheme for BDF2 time integration. More...
 
class  ResidualBasedPredictorCorrectorVelocityBossakSchemeTurbulent
 Bossak time scheme for the incompressible flow problem. More...
 
class  ResidualBasedSimpleSteadyScheme
 
class  SimpleSteadySensitivityBuilderScheme
 
class  VelocityBossakAdjointScheme
 
class  VelocityBossakSensitivityBuilderScheme
 
class  CompressibleNavierStokesExplicitSolvingStrategy
 Explicit solving strategy base class. More...
 
class  CompressibleNavierStokesExplicitSolvingStrategyBFECC
 
class  CompressibleNavierStokesExplicitSolvingStrategyRungeKutta
 Explicit solving strategy base class. More...
 
class  FractionalStepStrategy
 Fractional-step strategy for incompressible Navier-Stokes formulation This strategy implements a splitting scheme for the incompressible Navier-Stokes equations. It is intended to be used in combination with the FractionalStep element in the FluidDynamicsApplication. The fractional step index, which is stored in the ProcessInfo, takes the values 1 : Momentum step (calculate fractional step velocity) 2-3 : Unused (reserved for componentwise calculation of frac step velocity) 4 : Pressure step 5 : Computation of projections 6 : End of step velocity. More...
 
class  AccelerationLimitationUtilities
 
class  CompressibleElementRotationUtility
 A utility to rotate the local contributions of certain nodes to the system matrix, which is required to apply slip conditions in arbitrary directions. More...
 
class  DragUtilities
 Auxiliary utility to compute the drag force. More...
 
class  DynamicSmagorinskyUtils
 Helper class to dynamically determine a value for the Smagorinsly parameter. More...
 
class  EmbeddedData
 
class  EmbeddedDiscontinuousData
 
class  EstimateDtUtility
 Estimate the time step in a fluid problem to obtain a given Courant number. More...
 
class  FICData
 
class  FluidAdjointSlipUtilities
 
class  FluidAdjointTestUtilities
 
class  FluidAdjointUtilities
 
class  FluidAuxiliaryUtilities
 
class  FluidCalculationUtilities
 
class  FluidCharacteristicNumbersUtilities
 Fluid characteristic numbers calculation utility This class provides static methods to calculate the common adimensional magnitudes that characterize any fluid flow. More...
 
class  FluidElementData
 Base class for data containers used within FluidElement and derived types. More...
 
class  FluidElementUtilities
 Auxiliary and specialized functions for elements derived from FluidElement. More...
 
class  FluidTestUtilities
 
class  FractionalStepSettings
 Helper class to define solution strategies for FS_Strategy. More...
 
class  FractionalStepSettingsPeriodic
 Helper class to define solution strategies for FS_Strategy. More...
 
class  IntegrationPointToNodeTransformationUtility
 A utility for transforming values on integration points to nodes. More...
 
class  PeriodicConditionUtilities
 Auxiliary utilitiy to define periodic boundary conditions for flow problems. More...
 
class  QSVMSData
 
class  QSVMSDEMCoupledData
 
class  SolverSettings
 Helper class to define solution strategies for FS_Strategy. More...
 
class  StatisticsData
 Internal container for integration point statistitcs on a given element. More...
 
class  StatisticsRecord
 Main class for online statistics calculation. More...
 
class  StatisticsSampler
 Base class for statistical measurements. More...
 
class  ScalarAverageSampler
 This class manages the computation of the average of a scalar quantity. More...
 
class  VectorAverageSampler
 This class manages the computation of the average of a vector quantity. More...
 
class  VarianceSampler
 This class manages the computation of the (co)variance between two given quantities (scalar or vector). More...
 
class  SymmetricVarianceSampler
 This class manages the computation of the variance for a given quantity. More...
 
class  ComponentwiseVarianceSampler
 This class manages the computation of the (co)variance when one or both variables are Vector components. More...
 
class  ThirdOrderCorrelationSampler
 This class manages the computation of third order moments of scalars or vector components. More...
 
class  SymbolicStokesData
 
class  TimeIntegratedFICData
 
class  TimeIntegratedQSVMSData
 
class  TwoFluidNavierStokesAlphaMethodData
 
class  TwoFluidNavierStokesData
 
class  VorticityUtilities
 A set of functions to compute quantities of interest for turbulent flows. More...
 
class  WeaklyCompressibleNavierStokesData
 
class  KratosFluidDynamicsApplication
 Main class of the Fluid Dynamics Application. More...
 
class  TrilinosSpalartAllmarasTurbulenceModel
 Trilinos implementation of the Spalart-Allmaras turbulence model. More...
 
class  TrilinosStokesInitializationProcess
 A process to provide initial values for Navier-Stokes problems. More...
 
class  TrilinosFractionalStepSettings
 Helper class to define solution strategies for FS_Strategy. More...
 
class  TrilinosFractionalStepSettingsPeriodic
 Helper class to define solution strategies for FS_Strategy. More...
 
class  ParabolicProfileUtilities
 A set of functions to compute the Wall Shear Stress (WSS) More...
 
class  WssStatisticsUtilities
 A set of functions to compute the Wall Shear Stress (WSS) More...
 
class  KratosFluidDynamicsBiomedicalApplication
 Main class of the Fluid Dynamics Application. More...
 
class  HydraulicFluidAuxiliaryUtilities
 
class  KratosFluidDynamicsHydraulicsApplication
 Short class definition. More...
 
class  SteadyConvectionDiffusionFICElement
 
class  TransientConvectionDiffusionFICElement
 
class  TransientConvectionDiffusionFICExplicitElement
 
class  TransientConvectionDiffusionPFEM2FICElement
 Short class definition. More...
 
class  ExplicitForwardEulerScheme
 
class  GeneralizedNewmarkGN11Scheme
 
class  ElementUtilities
 
class  KratosFluidTransportApplication
 Short class definition. More...
 
class  EdgesStructureType
 
class  MatrixContainer
 
class  EdgesStructureTypeC2C
 
class  MatrixContainerC2C
 
class  EdgeBasedLevelSet
 
class  EdgebasedLevelsetAuxiliaryUtils
 
class  EdgeBasedLevelSetSubstep
 
class  KratosFreeSurfaceApplication
 Short class definition. More...
 
class  AitkenConvergenceAccelerator
 Aitken convergence accelerator Aitken formula-based. More...
 
class  ConstantRelaxationConvergenceAccelerator
 Constant relaxation convergence accelerator This utility corrects the iteration guess with a constant relaxation factor. More...
 
class  FSIUtils
 
class  MVQNFullJacobianConvergenceAccelerator
 MVQN acceleration scheme MultiVectorQuasiNewton convergence accelerator from Bogaers et al. 2016. More...
 
class  IBQNMVQNConvergenceAccelerator
 Interface Block Newton convergence accelerator Interface Block Newton equations convergence accelerator. More...
 
class  MVQNRandomizedSVDConvergenceAccelerator
 MVQN-RZ acceleration scheme RandomiZed Multi-Vector Quasi-Newton (MVQN-RZ) method convergence accelerator from Zorrilla and Rossi 2022. The MVQN-RZ overcomes the memory and computational bottlenecks of the original MVQN algorithm by doing a randomized SVD decomposition of the previous step inverse Jacobian approximation. This makes possible to reduce the complexity of the method from quadratic (MVQN) to linear (MVQN-RZ). The settings of the method are "automatic_jacobian_modes": if true automatically selects the number of modes to be used in the decomposition "jacobian_modes": if not automatic, the number of modes to be used in the decomposition "w_0": relaxation parameter to be used in the very first update "cut_off_tol": relative tolerance to avoid (almost) linear dependent information in the observation matrices "interface_block_newton": false for the IQN equations case and true for the IBQN equations once "limit_modes_to_iterations": if not automatic, limits the modes to the number of iterations to avoid numerical noise "min_rand_svd_extra_modes": minimum of extra modes to be used in the randomized SVD decomposition. More...
 
class  IBQNMVQNRandomizedSVDConvergenceAccelerator
 Interface Block Newton MVQN with randomized Jacobian convergence accelerator Interface Block Newton equations convergence accelerator with MVQN randomized SVD Jacobian for the subdomains. More...
 
class  JacobianEmulator
 Jacobian emulator. More...
 
class  MVQNRecursiveJacobianConvergenceAccelerator
 Recursive MVQN acceleration scheme Recursive MultiVectorQuasiNewton convergence accelerator. This convergence accelerator is an alternative implementation of the standard MVQN that avoids the storage of the. More...
 
class  NodalUpdateBaseClass
 
class  NodalUpdateNewmark
 
class  PartitionedFSIUtilities
 
class  SharedPointsMapper
 Short class definition. More...
 
class  KratosFSIApplication
 
class  AxisymmetricLineNormalFluidFlux2DDiffOrderCondition
 
class  AxisymmetricLineNormalLoad2DDiffOrderCondition
 
class  AxisymmetricUPwNormalFaceLoadCondition
 
class  GeneralUPwDiffOrderCondition
 
class  LineLoad2DDiffOrderCondition
 
class  LineNormalFluidFlux2DDiffOrderCondition
 
class  LineNormalLoad2DDiffOrderCondition
 
class  PwCondition
 
class  PwNormalFluxCondition
 
class  SurfaceLoad3DDiffOrderCondition
 
class  SurfaceNormalFluidFlux3DDiffOrderCondition
 
class  SurfaceNormalLoad3DDiffOrderCondition
 
class  GeoTCondition
 
struct  WaterFluxes
 
class  GeoTMicroClimateFluxCondition
 
class  GeoTNormalFluxCondition
 
class  UPwCondition
 
class  UPwFaceLoadCondition
 
class  UPwFaceLoadInterfaceCondition
 
class  UPwForceCondition
 
class  UPwNormalFaceLoadCondition
 
class  UPwNormalFluxCondition
 
class  UPwNormalFluxFICCondition
 
class  UPwNormalFluxInterfaceCondition
 
class  UPwLysmerAbsorbingCondition
 
class  BilinearCohesive2DLaw
 
class  BilinearCohesive3DLaw
 
class  ElasticIsotropicK03DLaw
 This class defines a small deformation linear elastic constitutive model for 3D cases. More...
 
class  LinearElastic2DBeamLaw
 This class defines a small deformation linear elastic constitutive model for plane strain beam elements. More...
 
class  LinearElastic2DInterfaceLaw
 This class defines a small deformation linear elastic constitutive model for plane strain cases. More...
 
class  LinearElastic3DInterfaceLaw
 This class defines a small deformation linear elastic constitutive model for plane strain cases. More...
 
class  GeoLinearElasticLaw
 
class  GeoLinearElasticPlaneStrain2DLaw
 This class defines a small deformation linear elastic constitutive model for plane strain cases. More...
 
class  LinearPlaneStrainK0Law
 This class defines a small deformation linear elastic constitutive model for plane strain cases. More...
 
class  GeoLinearElasticPlaneStress2DLaw
 This class defines a small deformation linear elastic constitutive model for plane stress cases. More...
 
class  SmallStrainUDSM2DInterfaceLaw
 Short class definition. More...
 
class  SmallStrainUDSM2DPlaneStrainLaw
 Short class definition. More...
 
class  SmallStrainUDSM3DInterfaceLaw
 Short class definition. More...
 
class  SmallStrainUDSM3DLaw
 Short class definition. More...
 
class  SmallStrainUMAT2DInterfaceLaw
 Short class definition. More...
 
class  SmallStrainUMAT2DPlaneStrainLaw
 Short class definition. More...
 
class  SmallStrainUMAT3DInterfaceLaw
 Short class definition. More...
 
class  SmallStrainUMAT3DLaw
 Short class definition. More...
 
class  GeoThermalDispersionLaw
 This class defines the thermal dispersion for heat cases. More...
 
class  DrainedUPwSmallStrainElement
 
class  GeoCableElement
 This is a cable element inheriting from the GeoTrussElement. More...
 
class  GeoCrBeamElement2D2N
 This is a 2D-2node beam element with 2 translational dofs and 1 rotational dof per node based on the same element in Structural Mechanics, modified to consider reset displacements. More...
 
class  GeoCrBeamElement3D2N
 This is a 3D-2node beam element with 3 translational dofs and 3 rotational dof per node, based on CrBeamElement3D2N element in Structural Mechanics application, modified to account for reset displacements. More...
 
class  GeoCrBeamElementLinear2D2N
 This is a linear 2D-2node beam element with 2 translational dofs and 1 rotational dof per node inheriting from CrBeamElementLinear2D2N. More...
 
class  GeoCrBeamElementLinear3D2N
 This is a linear 3D-2node beam element with 3 translational dofs and 3 rotational dof per node inheriting from CrBeamElement3D2N. More...
 
class  GeoCurvedBeamElement
 This is a geometrically non-linear (curved) beam element. The formulation can be found in papers written by Karan S. Surana, e.g: "1. Geometrically non-linear formulation for the axisymmetric shell elements" "2. Geometrically non-linear formulation for two dimensional curved beam elements" Discriptions of beam elements can be found in the following book, chapter 9. For 2D curved beams, see section 9.4: "Non-linear Finite element analysis of solids and structures" by De Borst et al. More...
 
class  GeoLinearTrussElement
 This is a linear truss element. More...
 
class  GeoTrussElementLinearBase
 This is a linear truss element inheriting from GeoTrussElementBase. More...
 
class  GeoStructuralBaseElement
 
class  GeoTrussElement
 This is a 2node truss element with reset-displacement. More...
 
class  GeoTrussElementBase
 This is a 2D-2node truss element with 2 translational dofs per node. More...
 
class  SmallStrainUPwDiffOrderAxisymmetricElement
 
class  SmallStrainUPwDiffOrderElement
 
class  SteadyStatePwElement
 
class  SteadyStatePwInterfaceElement
 
class  SteadyStatePwPipingElement
 
class  TransientPwElement
 
class  TransientPwInterfaceElement
 
class  TransientThermalElement
 
class  UPwBaseElement
 
class  UPwSmallStrainAxisymmetricElement
 
class  UPwSmallStrainAxisymmetricFICElement
 
class  UPwSmallStrainElement
 
class  UPwSmallStrainFICElement
 
class  UPwSmallStrainInterfaceElement
 
class  UPwSmallStrainLinkInterfaceElement
 
class  UPwUpdatedLagrangianElement
 Updated Lagrangian element for 2D and 3D geometries. More...
 
class  UPwUpdatedLagrangianFICElement
 Updated Lagrangian element for 2D and 3D geometries. More...
 
class  UndrainedUPwSmallStrainElement
 
class  UPwUpdatedLagrangianAxisymmetricElement
 
class  UPwUpdatedLagrangianAxisymmetricFICElement
 
class  UpdatedLagrangianUPwDiffOrderAxisymmetricElement
 
class  UpdatedLagrangianUPwDiffOrderElement
 Updated Lagrangian element for 2D and 3D geometries. More...
 
class  ActivateModelPartOperation
 This operation emulate the effect of an excavation by deactivating some parts of the computational domain. More...
 
class  DeactivateModelPartOperation
 This operation emulate the effect of an excavation by deactivating some parts of the computational domain. More...
 
class  ApplyBoundaryHydrostaticPressureTableProcess
 
class  ApplyBoundaryPhreaticLinePressureTableProcess
 
class  ApplyBoundaryPhreaticSurfacePressureTableProcess
 
class  ApplyConstantBoundaryHydrostaticPressureProcess
 
class  ApplyConstantBoundaryPhreaticLinePressureProcess
 
class  ApplyConstantBoundaryPhreaticSurfacePressureProcess
 
class  ApplyConstantHydrostaticPressureProcess
 
class  ApplyConstantInterpolateLinePressureProcess
 
class  ApplyConstantPhreaticLinePressureProcess
 
class  ApplyConstantPhreaticMultiLinePressureProcess
 
class  ApplyConstantPhreaticSurfacePressureProcess
 
class  ApplyExcavationProcess
 
class  ApplyHydrostaticPressureTableProcess
 
class  ApplyK0ProcedureProcess
 
class  ApplyNormalLoadTableProcess
 
class  ApplyPhreaticLinePressureTableProcess
 
class  ApplyPhreaticMultiLinePressureTableProcess
 
class  ApplyPhreaticSurfacePressureTableProcess
 
class  ApplyScalarConstraintTableProcess
 
class  ApplyVectorConstraintTableProcess
 
class  ApplyWriteScalarProcess
 
class  DeactivateConditionsOnInactiveElements
 Deactivate a condition if all elements attached to that are inactive. More...
 
class  FindNeighbourElementsOfConditionsProcess
 Finds list of elements attached to conditions. More...
 
class  PeriodicInterfaceProcess
 
class  SetAbsorbingBoundaryParametersProcess
 
class  SetMultipleMovingLoadsProcess
 Process to set and manage multiple moving loads offset according to a configuration variable. More...
 
class  SetParameterFieldProcess
 Process to set a parameter field. More...
 
class  RetentionLaw
 
class  RetentionLawFactory
 
class  SaturatedBelowPhreaticLevelLaw
 This class defines The Van-Genuchten Soil Water Characteristic Curve (retention curve) More...
 
class  SaturatedLaw
 This class defines a saturated Soil Water Characteristic Curve (retention curve) More...
 
class  VanGenuchtenLaw
 This class defines The Van-Genuchten Soil Water Characteristic Curve (retention curve) More...
 
class  ResidualBasedBlockBuilderAndSolverWithMassAndDamping
 Current class provides an implementation for builder and solving operations, while the global mass and damping matrices are stored. More...
 
class  BackwardEulerQuasistaticPwScheme
 
class  BackwardEulerQuasistaticUPwScheme
 
class  BackwardEulerScheme
 
class  BackwardEulerTScheme
 
class  GeneralizedNewmarkScheme
 
class  GeneralizedNewmarkTScheme
 
struct  FirstOrderScalarVariable
 
struct  SecondOrderVectorVariable
 
class  GeoMechanicsTimeIntegrationScheme
 
class  NewmarkDynamicUPwScheme
 
class  NewmarkQuasistaticDampedUPwScheme
 
class  NewmarkQuasistaticPwScheme
 
class  NewmarkQuasistaticUPwScheme
 
class  GeoMechanicsNewtonRaphsonErosionProcessStrategy
 
class  GeoMechanicsNewtonRaphsonStrategy
 
class  GeoMechanicsRammArcLengthStrategy
 
class  BuilderAndSolverFactory
 
class  ConditionUtilities
 
class  ConvergenceCriteriaFactory
 
class  GeoElementUtilities
 
class  FileInputUtility
 
class  InputUtility
 
class  InterfaceElementUtilities
 
class  JsonProcessInfoParser
 
class  GeoMechanicsMathUtilities
 
class  ParametersUtilities
 
class  ProcessFactory
 
class  ProcessInfoParser
 
struct  ProcessParameters
 
class  SchemeFactory
 
class  SolvingStrategyFactory
 
class  GeoStaticCondensationUtility
 This utilitiy condenses given degrees of freedom from any element stiffness matrix to model e.g. hinges. More...
 
class  StressStrainUtilities
 
class  GeoStructuralMechanicsElementUtilities
 
class  VariablesUtilities
 
class  AdaptiveTimeIncrementor
 
class  CustomWorkflowFactory
 
class  KratosExecute
 
class  KratosGeoSettlement
 
class  GeoOutputWriter
 
class  PrescribedTimeIncrementor
 
class  ScopedOutputFileAccess
 
class  SolvingStrategyWrapper
 
class  StrategyWrapper
 
class  TimeIncrementor
 
class  TimeLoopExecutor
 
class  TimeLoopExecutorInterface
 
struct  TimeStepEndState
 
class  TimeStepExecutor
 
class  KratosGeoMechanicsApplication
 Short class definition. More...
 
class  ReadVariableFunctor
 
class  WriteVariableFunctor
 
class  RegisteredComponentLookup
 A class for calling a functor on a variable specified by it's registered name. More...
 
class  KratosHDF5Application
 This application provides an interface to write Kratos data using HDF5. More...
 
class  CouplingLagrangeCondition
 Lagrange factor based coupling condition. More...
 
class  CouplingNitscheCondition
 Nitsche factor based coupling condition. More...
 
class  CouplingPenaltyCondition
 Penalty factor based coupling condition. More...
 
class  LoadCondition
 Condition for basic load types. More...
 
class  LoadMomentDirector5pCondition
 Condition for moment loads for the 5p shell based on directors. More...
 
class  OutputCondition
 Output condition. More...
 
class  SupportLagrangeCondition
 Lagrange Multiplier based support condition. More...
 
class  SupportNitscheCondition
 Nitsche-type based support condition. More...
 
class  SupportPenaltyCondition
 Condition for penalty support condition. More...
 
class  IgaMembraneElement
 
class  Shell3pElement
 
class  Shell5pElement
 
class  Shell5pHierarchicElement
 
class  TrussElement
 
class  TrussEmbeddedEdgeElement
 
class  IgaModeler
 Short class definition. More...
 
class  NurbsGeometryModeler
 
class  RefinementModeler
 Short class definition. More...
 
class  AssignIntegrationPointsToBackgroundElementsProcess
 
class  MapNurbsVolumeResultsToEmbeddedGeometryProcess
 
class  NitscheStabilizationModelPartProcess
 
class  OutputEigenValuesProcess
 
class  OutputQuadratureDomainProcess
 
class  AdditiveSchwarzPreconditioner
 
class  EigensolverNitscheStabilizationScheme
 An adapter scheme for obtaining stiffness and stabilization matrices for Nitsche eigenvalue problems. More...
 
class  EigensolverNitscheStabilizationStrategy
 Strategy for solving generalized eigenvalue problems to obtain Nitsche stabilization factor. More...
 
class  DirectorUtilities
 
class  IgaFlags
 Flags needed used in the IGAApplication. More...
 
class  KratosIgaApplication
 Short class definition. More...
 
class  EigenDenseBDCSVD
 
class  EigenDenseColumnPivotingHouseholderQRDecomposition
 
class  EigenDenseHouseholderQRDecomposition
 
class  EigenDenseJacobiSVD
 
class  DenseLinearSolverFactory
 Here we add the functions needed for the registration of dense linear solvers. More...
 
class  EigenDenseColPivHouseholderQRSolver
 
class  EigenDenseDirectSolver
 
class  DenseEigenvalueSolver
 
class  EigenDenseHouseholderQRSolver
 
class  EigenDenseLLTSolver
 
class  EigenDensePartialPivLUSolver
 
struct  SpaceType
 
struct  SpaceType< double >
 
struct  SpaceType< std::complex< double > >
 
class  EigenDirectSolver
 
class  EigenPardisoLDLTSolver
 
class  EigenPardisoLLTSolver
 
class  EigenPardisoLUSolver
 
class  EigenSparseCGSolver
 
class  EigenSparseLUSolver
 
class  EigenSparseQRSolver
 
class  EigensystemSolver
 
class  FEASTEigensystemSolver
 
class  SpectraSymGEigsShiftSolver
 
class  FEASTConditionNumberUtility
 This utility uses the FEAST solver to obtain (estimate) the the condition number of a regular matrix. More...
 
class  UblasWrapper
 
class  KratosLinearSolversApplication
 
class  BarycentricInterfaceInfo
 
class  BarycentricLocalSystem
 
class  BarycentricMapper
 Barycentric Mapper. More...
 
class  CouplingGeometryLocalSystem
 
class  CouplingGeometryMapper
 
class  AccessorInterpolativeMapperBase
 Definition of an accessor auxiliary class. More...
 
class  InterpolativeMapperBase
 
struct  NearestElementOptions
 Options for configuring the behavior of the Mapper. More...
 
class  NearestElementInterfaceInfo
 
class  NearestElementLocalSystem
 
class  NearestElementMapper
 Interpolative Mapper. More...
 
class  NearestNeighborInterfaceInfo
 
class  NearestNeighborLocalSystem
 
class  NearestNeighborMapper
 Nearest Neighbor Mapper. More...
 
class  Projection3D2DMapper
 This mapper simplifies the mapping between two model parts thanks to the projection over a reference plane. More...
 
class  MappingGeometriesModeler
 Short class definition. More...
 
class  InterfaceObjectConfigure
 
class  InterfaceCommunicator
 Object for exchanging data on the Interface. More...
 
class  InterfaceObject
 Object used by the bin-search. More...
 
class  InterfaceNode
 
class  InterfaceGeometryObject
 
class  PointWithId
 
class  ClosestPointsContainer
 
class  InterfaceVectorContainer
 Short class definition. More...
 
struct  MapperBackend
 
class  MapperInterfaceInfo
 Object for storing data that is needed to construct the local-mapping-system. More...
 
class  MapperLocalSystem
 This is the "Condition" of the mappers. More...
 
class  MappingMatrixUtilities
 
class  KratosMappingApplication
 Short class definition. More...
 
class  InterfaceCommunicatorMPI
 Object for exchanging data on the Interface in MPI. More...
 
struct  MapperMPIBackend
 
class  MedModelPartIO
 Short class definition. More...
 
class  MedTestingUtilities
 Short class definition. More...
 
class  KratosMedApplication
 
class  GaussPointItem
 Custom Gauss Point container to be used by the search. More...
 
class  MeshingFlags
 Flags needed used in the MeshingApplication. More...
 
class  MmgIO
 This class is a IO which uses the MMG library. More...
 
class  PfemGidGaussPointsContainer
 
class  PfemGidMeshContainer
 
class  EmbeddedMeshLocatorProcess
 Short class definition. More...
 
class  InternalVariablesInterpolationProcess
 This utilitiy has as objective to interpolate the values inside elements (and conditions?) in a model part, using as input the original model part and the new one. More...
 
class  MetricFastInit
 This process initializes the variables related with the ALM. More...
 
class  MetricErrorProcess
 This class is can be used to compute the metrics of the model part with a error already computed. More...
 
struct  AuxiliarHessianComputationVariables
 This is an auxiliar struct to store remeshing variables. More...
 
class  ComputeHessianSolMetricProcess
 This class is can be used to compute the metrics of the model part with an Hessian approach. More...
 
class  ComputeLevelSetSolMetricProcess
 This class is can be used to compute the metrics of the model part with a level set approach. More...
 
class  MmgProcess
 This class is a remesher which uses the MMG library. More...
 
class  MultiscaleRefiningProcess
 This class provides a non conforming refinement to perform multi scale analysis @detail This process manages three model parts, the coarse model part, refined model part and the visualization model part. This process can be constructed again with the refined model part as the coarse model part in order to get several subscales levels. The refinement is executed by the UniformRefinementUtility where the nodal flag TO_REFINE is set to True. Then, the coarse elements are removed from the visualization model part and the refined elements are added to the visualization model part. The coarsening is executed by the UniformRefinementUtility where the nodal flag TO_REFINE is set to False. Then, the refined elements are deleted and the corresponding coarse elements are added again to the visualization model part. Flags used by the process: TO_REFINE : Those entities will be refined MeshingFlags::REFINED : Once they are refined MeshingFlags::TO_COARSEN : When they aren't TO_REFINE and they doesn't have dependencies TO_ERASE : auxiliary flag NEW_ENTITY : auxiliary flag INTERFACE : the boundary of the refined model part INSIDE : the refined nodes which are not boundary Variables used by the process: SUBSCALE_INDEX : is increased from the coarse model part to the refined one FATHER_NODES : the pointers to the coarse nodes FATHER_NODES_WEIGHTS : the weights of the father nodes SLAVE_NODE : a pointer to the refined node (matching nodes between coarse and refined model parts) FATHER_ELEMENT : the pointer to the coarse element FATHER_CONDITION : the pointer to the coarse condition. More...
 
class  PointBoundary
 Custom Point container to be used to look in the boundary skin. More...
 
class  NodalValuesInterpolationProcess
 This utilitiy has as objective to interpolate the values inside elements (and conditions?) in a model part, using as input the original model part and the new one. More...
 
class  ParMmgProcess
 This class is a remesher which uses the PMMG library. More...
 
class  SetHMapProcess
 Short class definition. More...
 
class  BinBasedMeshTransfer
 This class allows the interpolation between non-matching meshes in 2D and 3D. More...
 
class  Cutting_Isosurface_Application
 CUTTING ISOSURFACE APPLICATION. More...
 
class  GradualVariableInterpolationUtility
 
class  LinearToQuadraticTetrahedraMeshConverter
 
class  LocalRefineGeometryMesh
 
class  LocalRefinePrismMesh
 
class  LocalRefineTetrahedraMesh
 
class  LocalRefineTetrahedraMeshOnlyOnBoundaries
 
class  LocalRefineTetrahedraMeshParallelToBoundaries
 
class  LocalRefineTriangleMesh
 
class  LocalRefineTriangleMeshConditions
 
class  LocalRefineTriangleMeshGeneric
 
class  MetricsMathUtils
 This class is used to compute some mathematical operations needed for the metrics computing. More...
 
struct  MMGMeshInfo
 Stores the Mmg mesh information. More...
 
class  MmgUtilities
 Provides the Kratos interface to the MMG library API. More...
 
struct  PMMGMeshInfo
 Stores the ParMmg mesh information. More...
 
class  ParMmgUtilities
 Provides the Kratos interface to the PMMG library API. More...
 
class  DistanceCalculator
 
class  MeshTransfer
 This class allows the interpolation between non-matching meshes in 2D and 3D. More...
 
class  TetgenVolumeMesher
 This class performs the (constrained) Delaunay meshing of the internal volume given a surface discretized in terms of triangular conditions. More...
 
class  TetrahedraReconnectUtility
 Short class definition. More...
 
class  UniformRefinementUtility
 This class splits all the elements until NUMBER_OF_DIVISIONS reaches the desired value @detail A node is added on the middle of each edge (and an extra node is added inside the quadrilaterals and tetrahedrons) and the nodal values are interpolated Once the element is split, the NUMBER_OF_DIVISIONS variable in increased by one Each division will create the following entities and delete the origin entity: Lines: 2 new lines Triangles: 4 new triangles (mesh quality is conserved) Quadrilaterals: 4 new quadrilaterals (mesh quality is conserved) Tetrahedrons: 8 new tetrahedrons (mesh quality is not conserved) Hexahedrons: 8 new hexahedrons (mesh quality is conserved) It only works with linear elements The splitting keeps the sub model parts. More...
 
class  MSuitePFEMModeler
 Short class definition. More...
 
class  PragmaticAdaptor
 
class  TetGenCDT
 Short class definition. More...
 
class  TetGenPfemContact
 Short class definition. More...
 
class  TetGenPfemModeler
 Short class definition. More...
 
class  TetGenPfemRefineFace
 Short class definition. More...
 
class  TetGenPfemModelerVms
 Short class definition. More...
 
class  TriGenCDT
 Short class definition. More...
 
class  TriGenDropletModeler
 Short class definition. More...
 
class  TriGenGLASSModeler
 Short class definition. More...
 
class  TriGenModeler
 Short class definition. More...
 
class  TriGenPFEMModeler
 Short class definition. More...
 
class  TriGenPFEMRefineSegment
 Short class definition. More...
 
class  TriGenPFEMModelerVMS
 Short class definition. More...
 
class  KratosMeshingApplication
 Short class definition. More...
 
class  LaplacianMeshMovingElement
 
class  StructuralMeshMovingElement
 
class  LaplacianMeshMovingStrategy
 Short class definition. More...
 
class  StructuralMeshMovingStrategy
 Short class definition. More...
 
class  AffineTransform
 Class for applying affine transformations. More...
 
class  FixedMeshALEUtilities
 Utility to perform the FM-ALE algorithm operations This utility implements the Fixed Mesh - Arbitrary Lagrangian Eulerian (FM-ALE) algorithm operations. After setting a virtual mesh, which is a copy of the problem background element mesh, it is moved in accordante to the immersed object movement. The virtual mesh movement is solved using a common ALE mesh solver (in this case the Laplacian mesh solver is used). Once the mesh movement, including the mesh velocity, have been computed, the origin mesh historical values (velocity and pressure), as well as the mesh velocity, are computed as a projection from the virtual mesh. This is required to consistently initialize the historical values when nodes change its topological status. More...
 
class  ParametricAffineTransform
 Class for applying parametrically defined affine transformations. More...
 
class  KratosMeshMovingApplication
 Short class definition. More...
 
class  TrilinosLaplacianMeshMovingStrategy
 Short class definition. More...
 
class  TrilinosStructuralMeshMovingStrategy
 Short class definition. More...
 
class  MetisDivideHeterogeneousInputInMemoryProcess
 Call Metis to divide an heterogeneous mesh, by partitioning its nodal graph. More...
 
class  MetisDivideHeterogeneousInputProcess
 Call Metis to divide an heterogeneous mesh, by partitioning its nodal graph. More...
 
class  MetisDivideSubModelPartsHeterogeneousInputProcess
 Short class definition. More...
 
class  MortonDivideInputToPartitionsProcess
 Short class definition. More...
 
class  MortonPartitioningProcess
 Short class definition. More...
 
class  LegacyPartitioningUtilities
 This class contains legacy versions of utilities used by the metis partitioners. More...
 
class  MetisPartitioningUtilities
 This class contains utilities used by the metis partitioners. More...
 
class  KratosMetisApplication
 Short class definition. More...
 
class  HelmholtzSurfShapeCondition
 This is the class of surface PDE/Helmholtz-based surface filtering. More...
 
class  HelmholtzSurfaceShapeCondition
 Short class definition. More...
 
class  HelmholtzJacobianStiffened3D
 This class defines constitutive model for shape filtering of solid 3D cases. This current implementation is basically elastic isotropic materical which computes young modules based on element's jacobian and helmholtz filter radius. More...
 
class  AdjointSmallDisplacementElement
 Short class definition. More...
 
class  HelmholtzSolidDataContainer
 
class  HelmholtzSolidShapeDataContainer
 
class  HelmholtzSurfaceDataContainer
 
struct  HelmholtzVariableData
 
struct  HelmholtzVariableData< 1 >
 
struct  HelmholtzVariableData< 2 >
 
struct  HelmholtzVariableData< 3 >
 
class  HelmholtzBulkElement
 Short class definition. More...
 
class  HelmholtzBulkShapeElement
 Short class definition. More...
 
class  HelmholtzElement
 Short class definition. More...
 
class  HelmholtzSurfShapeElement
 Short class definition. More...
 
class  HelmholtzSurfThicknessElement
 Short class definition. More...
 
class  HelmholtzStrategy
 Short class definition. More...
 
class  CollectiveExpression
 Construct a new CollectiveExpression instance. More...
 
class  CollectiveExpressionIO
 
class  ContainerExpressionUtils
 
struct  ContainerDataIO< ContainerDataIOTags::Properties >
 
class  SigmoidalProjectionUtils
 
class  EntityCalculationUtils
 
class  DampingFunction
 Short class definition. More...
 
class  EntityPoint
 
class  ExplicitFilter
 
class  FilterFunction
 Short class definition. More...
 
class  SymmetryUtility
 Short class definition. More...
 
class  ImplicitFilterUtils
 
class  OptimizationUtils
 
class  PropertiesVariableExpressionIO
 
class  LinearStrainEnergyResponseUtils
 
class  MassResponseUtils
 
class  MaxOverhangAngleResponseUtils
 
class  KratosOptimizationApplication
 Short class definition. More...
 
class  MPMGridAxisymLineLoadCondition2D
 Axisymmetric line load condition. More...
 
class  MPMGridAxisymPointLoadCondition
 Axisymmetric point load condition. More...
 
class  MPMGridBaseLoadCondition
 
class  MPMGridLineLoadCondition2D
 Short class definition. More...
 
class  MPMGridPointLoadCondition
 Short class definition. More...
 
class  MPMGridSurfaceLoadCondition3D
 
class  MPMParticleBaseCondition
 
class  MPMParticleBaseDirichletCondition
 
class  MPMParticleBaseLoadCondition
 Short class definition. More...
 
class  MPMParticlePenaltyDirichletCondition
 Short class definition. More...
 
class  MPMParticlePointLoadCondition
 Short class definition. More...
 
class  DispNewtonianFluid3DLaw
 
class  DispNewtonianFluidPlaneStrain2DLaw
 
class  BorjaCamClayPlasticFlowRule
 Short class definition. More...
 
class  MCPlasticFlowRule
 Short class definition. More...
 
class  MCStrainSofteningPlasticFlowRule
 Short class definition. More...
 
class  ParticleFlowRule
 Short class definition. More...
 
class  CamClayHardeningLaw
 Short class definition. More...
 
class  ExponentialStrainSofteningLaw
 Short class definition. More...
 
class  ParticleHardeningLaw
 Short class definition. More...
 
class  HenckyBorjaCamClayPlastic3DLaw
 
class  HenckyBorjaCamClayPlasticAxisym2DLaw
 
class  HenckyBorjaCamClayPlasticPlaneStrain2DLaw
 
class  HenckyMCPlastic3DLaw
 
class  HenckyMCPlasticAxisym2DLaw
 
class  HenckyMCPlasticPlaneStrain2DLaw
 
class  HenckyMCPlasticPlaneStrainUP2DLaw
 
class  HenckyMCStrainSofteningPlastic3DLaw
 
class  HenckyMCStrainSofteningPlasticAxisym2DLaw
 
class  HenckyMCStrainSofteningPlasticPlaneStrain2DLaw
 
class  HenckyMCPlasticUP3DLaw
 
class  HenckyElasticPlastic3DLaw
 
class  HenckyElasticPlasticAxisym2DLaw
 
class  HenckyElasticPlasticPlaneStrain2DLaw
 
class  HenckyElasticPlasticPlaneStrainUP2DLaw
 
class  HenckyElasticPlasticUP3DLaw
 
class  HyperElastic3DLaw
 
class  HyperElasticAxisym2DLaw
 
class  HyperElasticPlaneStrain2DLaw
 
class  HyperElasticPlaneStrainUP2DLaw
 
class  HyperElasticUP3DLaw
 
class  JohnsonCookThermalPlastic3DLaw
 
class  JohnsonCookThermalPlastic2DAxisymLaw
 
class  JohnsonCookThermalPlastic2DPlaneStrainLaw
 
class  LinearElastic3DLaw
 
class  LinearElasticAxisym2DLaw
 
class  LinearElasticPlaneStrain2DLaw
 
class  LinearElasticPlaneStress2DLaw
 
class  MCYieldCriterion
 Short class definition. More...
 
class  ModifiedCamClayYieldCriterion
 Short class definition. More...
 
class  ParticleYieldCriterion
 Short class definition. More...
 
class  MPMUpdatedLagrangian
 Large Displacement Lagrangian Element for 3D and 2D geometries. (base class) More...
 
class  MPMUpdatedLagrangianPQ
 Partitioned Quadrature Large Displacement Lagrangian Element for 3D and 2D geometries. (base class) More...
 
class  MPMUpdatedLagrangianUP
 Large Displacement Lagrangian Element for 3D and 2D geometries. (base class) More...
 
class  QuadraturePointPartitionedGeometry
 
class  ParticleVtkOutput
 ParticleVtkOutput A simple class that has functionality to write vtk output. More...
 
class  ParticleEraseProcess
 Delete particle elements and conditions with flag TO_ERASE. More...
 
class  MPMExplicitScheme
 A MPM explicit scheme. More...
 
class  MPMResidualBasedBossakScheme
 Bossak integration scheme (for linear and nonlinear dynamic problems) for displacements adjusted for Material Point Method. More...
 
class  MPMExplicitStrategy
 Short class definition. More...
 
class  MPMResidualBasedNewtonRaphsonStrategy
 Short class definition. More...
 
class  MPM_MPI_Utilities
 Provides place to add mpi related utility functions. More...
 
class  MPMBoundaryRotationUtility
 
class  MPMStressPrincipalInvariantsUtility
 
class  ParticleMechanicsMathUtilities
 
class  PQMPMPartitionUtilities
 This class includes several utilities necessaries for the PQMPM. More...
 
class  KratosParticleMechanicsApplication
 Short class definition. More...
 
class  MonolithicAutoSlipInlet3D
 Implements a wall condition for the PFEM2 formulation. More...
 
class  FixedPressure2D
 
class  FixedPressure3D
 
class  FixedVelocity2D
 
class  FixedVelocity3D
 
class  WaterFixedVelocity2D
 
class  FractionalStepPFEM22D
 
class  FractionalStepPFEM23D
 
class  MonolithicPFEM22D
 
class  MonolithicAutoSlipPFEM22D
 
class  MonolithicPFEM23D
 
class  MonolithicAutoSlipPFEM23D
 
class  Monolithic3FluidPFEM22D
 
class  Monolithic3FluidPFEM23D
 
class  NoNewtonianMonolithicPFEM22D
 
class  NoNewtonianMonolithicPFEM23D
 
class  QFluid2D
 This element implements a Multi-stage element (2D case) to be used in conjuntion with. More...
 
class  QFluid3D
 Short class definition. More...
 
class  VelocityEnrichedPFEM22D
 
class  BackwardEulerMonolithicAleScheme
 A first order scheme for testing purpose. More...
 
class  PFEM2_Explicit_Strategy
 
class  Fluid_Phase_PFEM2_Explicit_Strategy
 
class  FracStepStrategy
 Short class definition. More...
 
class  PFEM2MonolithicSlipScheme
 
class  PFEM2MonolithicSlipStrategy
 
class  ResidualBasedPredictorCorrectorVelocityBossakAleScheme
 Bossak time scheme for the incompressible flow problem. More...
 
class  AddFixedVelocityCondition2D
 
class  AddFixedVelocityCondition3D
 
class  AddFixedPressureCondition2D
 
class  AddFixedPressureCondition3D
 
class  AddWaterFixedVelocityCondition2D
 
class  CalculateWaterFraction
 
class  EnrichmentUtilitiesforPFEM2
 
class  MarkFluidProcess
 Short class definition. More...
 
class  MarkOuterNodesProcess
 Short class definition. More...
 
class  MoveParticleUtilityPFEM2
 
class  DistanceCalculator1
 
class  ParticleUtils
 
class  Pfem2Utils
 
class  PFEM_Particle
 PFEM Particle class. More...
 
class  PFEM_Particle_Fluid
 PFEM Particle class. More...
 
class  SaveLagrangianSurfaceProcess_p
 Short class definition. More...
 
class  MoveParticleUtilityDiffFluidOnly
 
class  Pfem2ApplyBCProcess
 Short class definition. More...
 
class  VisualizationUtilities
 
class  KratosPFEM2Application
 Short class definition. More...
 
class  UpdatedLagrangianSegregatedFluidElement
 Updated Lagrangian Segregated Fluid Element for 3D and 2D geometries. More...
 
class  AdaptiveTimeIntervalProcess
 Short class definition. More...
 
class  AssignPropertiesToNodesProcess
 The base class for fixing scalar variable Dof or array_1d component Dof processes in Kratos. More...
 
class  InletMesherProcess
 Insert a new Inlet Layer when the previous one has gone away. More...
 
class  InsertFluidNodesMesherProcess
 Refine Mesh Elements Process 2D and 3D. More...
 
class  ManageIsolatedNodesProcess
 Process for managing the time integration of variables for isolated nodes. More...
 
class  ManageSelectedElementsProcess
 Process for managing the time integration of variables for selected elements. More...
 
class  RecoverVolumeLossesProcess
 Move free surface to restore volume losses. More...
 
class  RefineFluidElementsInEdgesMesherProcess
 Refine Mesh Elements Process 2D and 3D. More...
 
class  RemoveFluidNodesMesherProcess
 Remove Fluid Nodes Process for 2D and 3D cases. More...
 
class  VolumeShapingProcess
 Move free surface to restore volume losses. More...
 
class  KratosPfemApplication
 Short class definition. More...
 
class  Bingham2DLaw
 
class  PfemFluidConstitutiveLaw
 This class contains the common infrastructure for the pfem fluid constitutive laws. More...
 
class  FrictionalViscoplastic2DLaw
 
class  FrictionalViscoplastic3DLaw
 
class  HerschelBulkley2DLaw
 
class  MuIRheology2DLaw
 
class  MuIRheology3DLaw
 
class  BinghamTemperatureDependent2DLaw
 
class  BinghamTemperatureDependent3DLaw
 
class  FrictionalViscoplasticTemperatureDependent2DLaw
 
class  FrictionalViscoplasticTemperatureDependent3DLaw
 
class  MuIRheologyTemperatureDependent2DLaw
 
class  MuIRheologyTemperatureDependent3DLaw
 
class  Hypoelastic2DLaw
 
class  Hypoelastic3DLaw
 
class  PfemSolidConstitutiveLaw
 This class contains the common infrastructure for solid constitutive laws. More...
 
class  HypoelasticTemperatureDependent2DLaw
 
class  HypoelasticTemperatureDependent3DLaw
 
class  ThreeStepFirstOrderUpdatedLagrangianElement
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  ThreeStepSecondOrderPspgUpdatedLagrangianElement
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  ThreeStepSecondOrderUpdatedLagrangianElement
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  ThreeStepUpdatedLagrangianElement
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  TwoStepUpdatedLagrangianElement
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  TwoStepUpdatedLagrangianVPImplicitElement
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  TwoStepUpdatedLagrangianVPImplicitFluidElement
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  TwoStepUpdatedLagrangianVPImplicitFluidFicElement
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  TwoStepUpdatedLagrangianVPImplicitFluidPspgElement
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  TwoStepUpdatedLagrangianVPImplicitSolidElement
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  UpdatedLagrangianElement
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  UpdatedLagrangianVImplicitSolidElement
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  AssignScalarFieldToPfemEntitiesProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  AssignScalarVariableToPfemEntitiesProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  AssignVectorFieldToPfemEntitiesProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  AssignVectorVariableToPfemConditionsProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  BuildMeshBoundaryForFluidsProcess
 Short class definition. More...
 
class  BuildModelPartBoundaryForFluidsProcess
 Short class definition. More...
 
class  CalculateWaveHeightProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  ComputeAveragePfemMeshParametersProcess
 Refine Mesh Elements Process 2D and 3D. More...
 
class  FindNodalHForRigidWallsProcess
 Refine Mesh Elements Process 2D and 3D. More...
 
class  PFEMFixFreeVelocityOnNodesProcess
 
class  FixScalarPfemDofProcess
 The base class for fixing scalar variable Dof or array_1d component Dof processes in Kratos. More...
 
class  FreeScalarPfemDofProcess
 The base class for freeing scalar variable Dof or array_1d component Dof processes in Kratos. More...
 
class  GenerateNewConditionsMesherForFluidsProcess
 Short class definition. More...
 
class  GenerateNewNodesBeforeMeshingProcess
 Refine Mesh Elements Process 2D and 3D. More...
 
class  InletManagementProcess
 Refine Mesh Elements Process 2D and 3D. More...
 
class  LagrangianRotationProcess
 Process used to rotate lagrangian model parts using Rodrigues' rotation formula. More...
 
class  ModelStartEndMeshingForFluidsProcess
 Short class definition. More...
 
class  RemoveMeshNodesForFluidsProcess
 Remove Mesh Nodes Process for 2D and 3D cases. More...
 
class  SelectMeshElementsForFluidsProcess
 Refine Mesh Elements Process 2D and 3D. More...
 
class  SetActiveFlagMesherProcess
 Short class definition. More...
 
class  SetActiveFlagProcess
 Short class definition. More...
 
class  SetDummyPropertyForRigidElementsProcess
 
class  SetEulerianInletProcess
 Refine Mesh Elements Process 2D and 3D. More...
 
class  SetLagrangianInletProcess
 Refine Mesh Elements Process 2D and 3D. More...
 
class  SetMainMaterialPropertyProcess
 Short class definition. More...
 
class  SetMaterialPropertiesForThermalCouplingProcess
 This process sets the nodal value of thermal properties (density, conductivity and capacity) that depends on the temperature, which is necesssary for solving the termal part, since the convection-diffusion solver gets these nodal values for assembling the system. The value of these properties are computed according to the constitutive law of the incident elements of each node, using the nodal temperature, and the average is taken as the nodal value for the property. More...
 
class  SetMaterialPropertiesFromFluidToRigidNodesProcess
 Short class definition. More...
 
class  SetMaterialPropertiesToFluidNodesProcess
 Short class definition. More...
 
class  SetMaterialPropertiesToSolidNodesProcess
 Short class definition. More...
 
class  SetMeshVelocityForThermalCouplingProcess
 This method sets the MESH_VELOCITY equal to the nodal VELOCITY. More...
 
class  SplitElementsProcess
 Short class definition. More...
 
class  TransferModelPartElementsProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  UpdateConditionsOnFreeSurfaceProcess
 This process updates the conditions applied to the free surface after the remeshing. More...
 
class  UpdateThermalModelPartProcess
 
class  NodalResidualBasedEliminationBuilderAndSolver
 Current class provides an implementation for standard builder and solving operations. More...
 
class  NodalResidualBasedEliminationBuilderAndSolverContinuity
 Current class provides an implementation for standard builder and solving operations. More...
 
class  NodalResidualBasedEliminationBuilderAndSolverContinuityForFSI
 Current class provides an implementation for standard builder and solving operations. More...
 
class  NodalResidualBasedEliminationBuilderAndSolverForFSI
 Current class provides an implementation for standard builder and solving operations. More...
 
class  GaussSeidelLinearStrategy
 Short class definition. More...
 
class  NodalTwoStepVPStrategy
 
class  NodalTwoStepVPStrategyForFSI
 
class  ThreeStepVPStrategy
 
class  TwoStepVPDEMcouplingStrategy
 
class  TwoStepVPStrategy
 
class  TwoStepVPThermalStrategy
 
class  VPStrategy
 
class  CalculateWaveHeightUtility
 This function computes the wave height at a given point. More...
 
class  PFEMMoveMeshUtility
 This utility resets the nodes of a PFEM fluid ModelPart, used especially in the PFEM-FEM coupling. More...
 
class  PfemFluidGidIO
 
class  TwoStepVPSolverSettings
 Helper class to define solution strategies for TwoStepVPStrategy. More...
 
class  TwoStepVPSettings
 Helper class to define solution strategies for FS_Strategy. More...
 
class  KratosPfemFluidDynamicsApplication
 Short class definition. More...
 
class  PFEMFlags
 
class  BorjaHenckyCamClayPlastic3DLaw
 
class  BorjaHenckyCamClayPlasticAxisym2DLaw
 
class  BorjaHenckyCamClayPlasticPlaneStrain2DLaw
 
class  BorjaCamClayExplicitFlowRule
 Short class definition. More...
 
class  J2ExplicitFlowRule
 Short class definition. More...
 
class  NonAssociativeExplicitPlasticFlowRule
 Short class definition. More...
 
class  TrescaExplicitFlowRule
 Short class definition. More...
 
class  CamClayYieldCriterion
 Short class definition. More...
 
class  J2YieldCriterion
 Short class definition. More...
 
class  NewTrescaYieldCriterion
 Short class definition. More...
 
struct  TrescaStressInvariants
 
class  TrescaYieldCriterion
 Short class definition. More...
 
class  HenckyJ2PlasticAxisym2DLaw
 
class  HenckyJ2PlasticPlaneStrain2DLaw
 
class  HenckyTresca3DLaw
 
class  HenckyTrescaPlasticAxisym2DLaw
 
class  HenckyTrescaPlasticPlaneStrain2DLaw
 
class  HenckyPlasticUPJ2Axisym2DLaw
 
class  HenckyPlasticUPJ2PlaneStrain2DLaw
 
class  HenckyPlasticUPTrescaAxisym2DLaw
 
class  HenckyPlasticUPTrescaPlaneStrain2DLaw
 
class  NewHenckyTrescaPlasticAxisym2DLaw
 
class  NewHenckyTrescaPlasticPlaneStrain2DLaw
 
class  NonLinearHenckyElasticPlastic3DLaw
 
class  NonLinearHenckyElasticPlasticAxisym2DLaw
 
class  NonLinearHenckyElasticPlasticPlaneStrain2DLaw
 
class  NonLinearHenckyElasticPlasticUP3DLaw
 
class  NonLinearHenckyElasticPlasticUPAxisym2DLaw
 
class  NonLinearHenckyElasticPlasticUPPlaneStrain2DLaw
 
class  AxisymUpdatedLagrangianUJElement
 
class  AxisymUpdatedLagrangianUJWwPDMEElement
 Updated Lagrangian Large Displacement Lagrangian U-W Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  AxisymUpdatedLagrangianUJWwPElement
 Updated Lagrangian Large Displacement Lagrangian U-W Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  AxisymUpdatedLagrangianUJwPElement
 Updated Lagrangian Large Displacement Lagrangian U-wP Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  AxisymUpdatedLagrangianUPwPElement
 Updated Lagrangian Large Displacement Lagrangian U-wP Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  AxisymUpdatedLagrangianUPressureElement
 
class  AxisymUpdatedLagrangianUwPElement
 Axisymmetric Updated Lagrangian Large Displacement Lagrangian U-Pw Element. More...
 
class  AxisymUpdatedLagrangianUwPStabElement
 Stabilization of the Axisim Updated Lagrangian Large Displacement Lagrangian U-wP Element for 3D and 2D geometries. More...
 
class  SmallDisplacementUWwPElement
 Updated Lagrangian Large Displacement Lagrangian U-W Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  TotalUpdatedLagrangianElement
 Total Updated Lagrangian Element for 3D and 2D geometries. More...
 
class  TotalUpdatedLagrangianUPElement
 Total Updated Lagrangian U-P Element for 3D and 2D geometries. Linear Triangles and Tetrahedra. More...
 
class  UpdatedLagrangianUJElement
 Updated Lagrangian Large Displacement Lagrangian U-wP Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  UpdatedLagrangianUJPElement
 
class  UpdatedLagrangianUJWwPDMEElement
 Updated Lagrangian Large Displacement Lagrangian U-W Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  UpdatedLagrangianUJWwPElement
 Updated Lagrangian Large Displacement Lagrangian U-W Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  UpdatedLagrangianUJWwPHOElement
 Updated Lagrangian Large Displacement Lagrangian U-W Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  UpdatedLagrangianUJwPElement
 Updated Lagrangian Large Displacement Lagrangian U-wP Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  UpdatedLagrangianUPwPElement
 Updated Lagrangian Large Displacement Lagrangian U-wP Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  UpdatedLagrangianUPressureElement
 Large Displacement Lagrangian U-P Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  UpdatedLagrangianUWElement
 Updated Lagrangian Large Displacement Lagrangian U-W Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  UpdatedLagrangianUWwPDMEElement
 Updated Lagrangian Large Displacement Lagrangian U-W Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  UpdatedLagrangianUWwPElement
 Updated Lagrangian Large Displacement Lagrangian U-W Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  UpdatedLagrangianUwPElement
 Updated Lagrangian Large Displacement Lagrangian U-wP Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  UpdatedLagrangianUwPStabElement
 Updated Lagrangian Large Displacement U-Pw Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  RefineConditionsInContactMesherProcess
 Refine Mesh Boundary Process. More...
 
class  SetMechanicalInitialStateProcess
 
class  ResidualBasedBossakScheme
 
class  AxisymWaterPressureUtilities
 
class  AxisymWaterPressureJacobianUtilities
 
class  DeviatoricPlaneShapeUtilities
 
class  WaterPressureUtilities
 
class  WaterPressureJacobianUtilities
 
class  KratosPfemSolidMechanicsApplication
 Short class definition. More...
 
class  UPwDischargeCondition
 
class  FlowRule
 Short class definition. More...
 
class  IsotropicDamageFlowRule
 Short class definition. More...
 
class  LocalDamageFlowRule
 
class  NonlocalDamageFlowRule
 
class  ExponentialDamageHardeningLaw
 Short class definition. More...
 
class  HardeningLaw
 Short class definition. More...
 
class  ModifiedExponentialDamageHardeningLaw
 Short class definition. More...
 
class  ModifiedMisesYieldCriterion
 Short class definition. More...
 
class  SimoJuYieldCriterion
 Short class definition. More...
 
class  YieldCriterion
 Short class definition. More...
 
class  ElasticCohesive2DLaw
 
class  ElasticCohesive3DLaw
 
class  ElastoPlasticModMohrCoulombCohesive2DLaw
 
class  ElastoPlasticModMohrCoulombCohesive3DLaw
 
class  ElastoPlasticMohrCoulombCohesive2DLaw
 
class  ElastoPlasticMohrCoulombCohesive3DLaw
 
class  ExponentialCohesive2DLaw
 
class  ExponentialCohesive3DLaw
 
class  HistoryLinearElastic3DLaw
 
class  HistoryLinearElasticPlaneStrain2DLaw
 
class  HistoryLinearElasticPlaneStress2DLaw
 
class  HyperElasticPlastic3DLaw
 
class  IsotropicDamageCohesive2DLaw
 
class  IsotropicDamageCohesive3DLaw
 
class  LinearElasticPlastic3DLaw
 
class  LocalDamage3DLaw
 
class  LocalDamagePlaneStrain2DLaw
 
class  LocalDamagePlaneStress2DLaw
 
class  ModifiedMisesNonlocalDamage3DLaw
 
class  ModifiedMisesNonlocalDamagePlaneStrain2DLaw
 
class  ModifiedMisesNonlocalDamagePlaneStress2DLaw
 
class  NonlocalDamage3DLaw
 
class  NonlocalDamagePlaneStrain2DLaw
 
class  NonlocalDamagePlaneStress2DLaw
 
class  SimoJuLocalDamage3DLaw
 
class  SimoJuLocalDamagePlaneStrain2DLaw
 
class  SimoJuLocalDamagePlaneStress2DLaw
 
class  SimoJuNonlocalDamage3DLaw
 
class  SimoJuNonlocalDamagePlaneStrain2DLaw
 
class  SimoJuNonlocalDamagePlaneStress2DLaw
 
class  UPwElement
 
class  PoromechanicsFaceLoadControlModuleProcess
 FaceLoad control module for displacements. More...
 
class  PoroExplicitCDScheme
 An explicit forward euler scheme with a split of the inertial term. More...
 
class  PoroExplicitVVScheme
 An explicit forward euler scheme with a split of the inertial term. More...
 
class  PoroNewmarkDynamicUPwScheme
 
class  PoroNewmarkQuasistaticDampedUPwScheme
 
class  PoroNewmarkQuasistaticUPwScheme
 
class  PoromechanicsExplicitNonlocalStrategy
 
class  PoromechanicsExplicitStrategy
 
class  PoromechanicsNewtonRaphsonNonlocalStrategy
 
class  PoromechanicsNewtonRaphsonStrategy
 
class  PoromechanicsRammArcLengthNonlocalStrategy
 
class  PoromechanicsRammArcLengthStrategy
 
class  FracturePropagation2DUtilities
 
class  FracturePropagation3DUtilities
 
class  InitialStress2DUtilities
 
class  InitialStress3DUtilities
 
class  IsotropicDamageUtilities
 
class  NonlocalDamage2DUtilities
 
class  NonlocalDamage3DUtilities
 
class  NonlocalDamageUtilities
 
class  PoroConditionUtilities
 
class  PoroElementUtilities
 
class  SolidMechanicsMathUtilities
 
class  KratosPoromechanicsApplication
 
class  FractionalStepKBasedWallCondition
 Implements a wall condition for the monolithic formulation. More...
 
class  IncompressiblePotentialFlowVelocityInletCondition
 
class  ScalarWallFluxCondition
 
class  ScalarWallFluxConditionData
 
class  VMSMonolithicKBasedWallCondition
 
class  RansNewtonian2DLaw
 This class is extending Newtonian2DLaw in FluidDynamicsApplication. More...
 
class  RansNewtonian3DLaw
 This class is extending Newtonian3DLaw in FluidDynamicsApplication. More...
 
class  ConvectionDiffusionReactionCrossWindStabilizedElement
 
class  ConvectionDiffusionReactionElement
 
class  ConvectionDiffusionReactionElementData
 Base class to hold Convection-Diffusion-Reaction transport equation data. More...
 
class  ConvectionDiffusionReactionResidualBasedFluxCorrectedElement
 
class  IncompressiblePotentialFlowVelocityElement
 
class  LaplaceElement
 
class  RansApplyExactNodalPeriodicConditionProcess
 A process to create periodic conditions between two boundaries. More...
 
class  RansApplyFlagToSkinProcess
 Apply a specific flag for nodes and conditions. More...
 
class  RansClipScalarVariableProcess
 Clips given scalar variable to a range. More...
 
class  RansComputeReactionsProcess
 Computes the reaction forces for slip modelpart, can be further used for drag calculation. More...
 
class  RansEpsilonTurbulentMixingLengthInletProcess
 Sets epsilon value best on turbulent mixing length. More...
 
class  RansFormulationProcess
 This class is extending standard Process interface. More...
 
class  RansKTurbulentIntensityInletProcess
 Set turbulent kinetic energy value based on the given turbulent intensity. More...
 
class  RansLineOutputProcess
 Line output process. More...
 
class  RansNutKEpsilonUpdateProcess
 Calculates turbulent kinematic viscosity. More...
 
class  RansNutKOmegaSSTUpdateProcess
 Calculates turbulent kinematic viscosity. More...
 
class  RansNutKOmegaUpdateProcess
 Calculates turbulent kinematic viscosity. More...
 
class  RansNutNodalUpdateProcess
 Updates nodal VISCOSITY. More...
 
class  RansNutYPlusWallFunctionUpdateProcess
 
class  RansOmegaTurbulentMixingLengthInletProcess
 Sets omega value best on turbulent mixing length. More...
 
class  RansWallDistanceCalculationProcess
 
class  RansWallFunctionUpdateProcess
 
class  AlgebraicFluxCorrectedSteadyScalarScheme
 Algebraic flux corrected scalar steady transport scheme. More...
 
class  BossakRelaxationScalarScheme
 A scheme for steady and dynamic equations, using Bossak time integration. More...
 
class  RelaxedDofUpdater
 Utility class to update the values of degree of freedom (Dof) variables after solving the system. More...
 
class  SteadyScalarScheme
 
class  RansVariableDifferenceNormsCalculationUtility
 This class is used to calculate difference norms of a given variable. More...
 
class  KratosRANSApplication
 Short class definition. More...
 
class  HRomVisualizationMeshModeler
 Modeler for setting up HROM visualization meshes This modeler is intended to be used for setting up HROM visualization meshes From a parent HROM model part (the model part on which the HROM problem is solved) this modeler fills up the required data in the provided visualization model part. The process info, variable list and buffer size are taken from the provided HROM model part while the ROM_BASIS and DOFs are retrieved from the RomParameters.json. More...
 
class  GlobalPetrovGalerkinROMBuilderAndSolver
 This class provides an implementation for the GlobalPetrovGalerkinROM builder and solver operations. This Builder and Solver (B&S) now inherits from the GlobalROMBuilderAndSolver, which in turn inherits from the ResidualBasedBlockBuilderAndSolver. The Right-Hand Side (RHS) is composed of unbalanced loads (residual) and is constructed using the ResidualBasedBlockBuilderAndSolver. Similarly, the Left-Hand Side (LHS) is constructed using the ResidualBasedBlockBuilderAndSolver and is then multiplied by the ROM RIGHT BASIS. We then project it onto the ROM LEFT BASIS, yielding a rectangular system (ROM size) that is then solved using the QR decomposition. The degrees of freedom are rearranged so that the restrained ones are placed at the end of the system, ordered inversely to the DofSet, mirroring the arrangement in the Full Order Model (FOM). More...
 
class  GlobalROMBuilderAndSolver
 
class  LeastSquaresPetrovGalerkinROMBuilderAndSolver
 This class provides an implementation for the LeastSquaresPetrovGalerkinROM builder and solver operations. This B&S now inherits from the GlobalROMBuilderAndSolver, which in turn inherits from the ResidualBasedBlockBuilderAndSolver. The RHS is composed of unbalanced loads (residual) and is constructed using the ResidualBasedBlockBuilderAndSolver. Similarly, the LHS is constructed using the ResidualBasedBlockBuilderAndSolver and is then multiplied by the ROM RIGHT BASIS. This results in a rectangular system with dimensions of FOM size by ROM size. This system can be solved using either the normal equations or the QR decomposition. The degrees of freedom are rearranged so that the restrained ones are placed at the end of the system, ordered inversely to the DofSet, mirroring the arrangement in the FOM. More...
 
class  PetrovGalerkinROMBuilderAndSolver
 Current class provides an implementation for PetrovGalerkinROM builder and solving operations. More...
 
class  ROMBuilderAndSolver
 
class  RomAuxiliaryUtilities
 
class  RomResidualsUtility
 
class  KratosRomApplication
 Short class definition. More...
 
class  BoussinesqCondition
 Implementation of a condition for shallow water waves problems. More...
 
class  ConservativeCondition
 Implementation of a condition for shallow water waves problems. More...
 
class  PrimitiveCondition
 Implementation of a condition for shallow water waves problems. More...
 
class  WaveCondition
 Implementation of a condition for shallow water waves problems. More...
 
class  BoussinesqElement
 Implementation of a linear element for shallow water problems. More...
 
class  ConservativeElement
 Implementation of a linear element for shallow water problems. More...
 
class  ConservativeElementFC
 Implementation of a linear element for shallow water problems. More...
 
class  ConservativeElementRV
 Implementation of a linear element for shallow water problems. More...
 
class  CrankNicolsonWaveElement
 Implementation of a linear element for shallow water problems. More...
 
class  PrimitiveElement
 Implementation of a linear element for shallow water problems. More...
 
class  WaveElement
 Implementation of a linear element for shallow water problems. More...
 
class  ChezyLaw
 The base class for the bottom and surface friction laws. More...
 
class  FrictionLawsFactory
 The base class for the bottom and surface friction laws. More...
 
class  ManningLaw
 The base class for the bottom and surface friction laws. More...
 
class  NodalManningLaw
 This class computes the bottom friction according to the Manning law. More...
 
class  WindWaterFriction
 The base class for the bottom and surface friction laws. More...
 
class  MeshMovingModeler
 Tools for lagrangian computations. More...
 
class  ApplyPerturbationFunctionProcess
 This process assigns a default value or a perturbation if the node is close to an influence area. More...
 
class  ApplySinusoidalFunctionProcess
 The aim of this process is to generate sinusoidal waves. More...
 
class  CalculateDistanceToBoundaryProcess
 Calculate the minimum distance from all the nodes to a boundary condition in 2D. More...
 
class  DepthIntegrationProcess
 Calculate the minimum distance from all the nodes to a boundary condition in 2D. More...
 
class  WriteFromSwAtInterfaceProcess
 Calculate the minimum distance from all the nodes to a boundary condition in 2D. More...
 
class  FluxCorrectedShallowWaterScheme
 BDF integration scheme (for dynamic problems) with flux correction for extra diffusion to ensure monotonic solutions. More...
 
class  ResidualBasedAdamsMoultonScheme
 Predictor-corrector semi imlicit scheme for the Boussinesq element. More...
 
class  ShallowWaterResidualBasedBDFScheme
 BDF integration scheme (for dynamic problems) More...
 
class  DerivativesRecoveryUtility
 Superconvergent patch recovery for linear meshes using quadratic polynomials. More...
 
class  EstimateTimeStepUtility
 Utility to estimate the time step in terms of the courant number. More...
 
class  FlowRateSlipUtility
 Tools to apply slip conditions @detail A utility to rotate the local contributions of certain nodes to the system matrix, which is required to apply slip conditions in arbitrary directions. More...
 
class  FluxLimiter
 This is a helper class to separate the physics from the flux corrected scheme. More...
 
class  InterpolateSwToPfemUtility
 
class  MoveShallowMeshUtility
 Tools for lagrangian computations. More...
 
class  PhaseFunction
 This class is a wrapper of useful utilities for shallow water computations. More...
 
class  ShallowWaterUtilities
 This class is a wrapper of useful utilities for shallow water computations. More...
 
class  KratosShallowWaterApplication
 Short class definition. More...
 
class  DampingUtilities
 Short class definition. More...
 
class  DirectionDampingUtilities
 Class for direction damping of the shape update. More...
 
class  GeometryUtilities
 Short class definition. More...
 
class  UniversalFileIO
 Short class definition. More...
 
class  MapperVertexMorphing
 Short class definition. More...
 
class  MapperVertexMorphingAdaptiveRadius
 Short class definition. More...
 
class  MapperVertexMorphingImprovedIntegration
 Short class definition. More...
 
class  MapperVertexMorphingMatrixFree
 Short class definition. More...
 
class  MapperVertexMorphingSymmetric
 Short class definition. More...
 
class  SymmetryBase
 
class  SymmetryPlane
 
class  SymmetryRevolution
 
class  MeshControllerUtilities
 Short class definition. More...
 
class  OptimizationUtilities
 Short class definition. More...
 
class  FaceAngleResponseFunctionUtility
 Short class definition. More...
 
class  SearchBasedFunctions
 Short class definition. More...
 
class  KratosShapeOptimizationApplication
 Short class definition. More...
 
class  BoundaryCondition
 General Boundary Condition base type for 3D and 2D geometries. More...
 
class  AxisymmetricLineElasticCondition
 Elastic Condition for 2D axisymmetric geometries. (base class) More...
 
class  AxisymmetricPointElasticCondition
 Axisymmetric point elastic condition for 2D geometries. More...
 
class  ElasticCondition
 Elastic Condition for 3D and 2D geometries. (base class) More...
 
class  LineElasticCondition
 Line load condition for 3D and 2D geometries. More...
 
class  PointElasticCondition
 Point Load Condition for 3D and 2D geometries. (base class) More...
 
class  SurfaceElasticCondition
 
class  AxisymmetricLineLoadCondition
 Load Condition for 2D axisymmetric geometries. (base class) More...
 
class  AxisymmetricPointLoadCondition
 Axisymmetric point load condition for 2D geometries. More...
 
class  LineLoadCondition
 Line load condition for 3D and 2D geometries. More...
 
class  PointLoadCondition
 Point Load Condition for 3D and 2D geometries. (base class) More...
 
class  SurfaceLoadCondition
 
class  LineMomentCondition
 Line load condition for 3D and 2D geometries. More...
 
class  MomentCondition
 Load Condition for 3D and 2D geometries. (base class) More...
 
class  PointMomentCondition
 Point Load Condition for 3D and 2D geometries. (base class) More...
 
class  SurfaceMomentCondition
 
class  LineHeatFluxCondition
 Short class definition. More...
 
class  LinearAssociativePlasticFlowRule
 Short class definition. More...
 
class  NonLinearAssociativePlasticFlowRule
 Short class definition. More...
 
class  NonLinearRateDependentPlasticFlowRule
 Short class definition. More...
 
class  BakerJohnsonCookThermalHardeningLaw
 Short class definition. More...
 
class  JohnsonCookThermalHardeningLaw
 Short class definition. More...
 
class  LinearIsotropicKinematicHardeningLaw
 Short class definition. More...
 
class  NonLinearIsotropicKinematicHardeningLaw
 Short class definition. More...
 
class  NonLinearIsotropicKinematicThermalHardeningLaw
 Short class definition. More...
 
class  MisesHuberThermalYieldCriterion
 Short class definition. More...
 
class  MisesHuberYieldCriterion
 Short class definition. More...
 
class  HyperElasticPlasticAxisym2DLaw
 
class  HyperElasticPlasticJ23DLaw
 
class  HyperElasticPlasticJ2Axisym2DLaw
 
class  HyperElasticPlasticJ2PlaneStrain2DLaw
 
class  HyperElasticPlasticPlaneStrain2DLaw
 
class  HyperElasticPlasticThermalBakerJohnsonCookPlaneStrain2DLaw
 
class  HyperElasticPlasticThermalJ2PlaneStrain2DLaw
 
class  HyperElasticPlasticThermalJohnsonCookPlaneStrain2DLaw
 
class  HyperElasticPlasticThermalUPBakerJohnsonCookPlaneStrain2DLaw
 
class  HyperElasticPlasticThermalUPJ23DLaw
 
class  HyperElasticPlasticThermalUPJ2Axisym2DLaw
 
class  HyperElasticPlasticThermalUPJ2PlaneStrain2DLaw
 
class  HyperElasticPlasticThermalUPJohnsonCookAxisym2DLaw
 
class  HyperElasticPlasticThermalUPJohnsonCookPlaneStrain2DLaw
 
class  HyperElasticPlasticUP3DLaw
 
class  HyperElasticPlasticUPAxisym2DLaw
 
class  HyperElasticPlasticUPJ23DLaw
 
class  HyperElasticPlasticUPJ2Axisym2DLaw
 
class  HyperElasticPlasticUPJ2PlaneStrain2DLaw
 
class  HyperElasticPlasticUPPlaneStrain2DLaw
 
class  HyperElasticUPAxisym2DLaw
 
class  HyperElasticUPPlaneStrain2DLaw
 
class  IsotropicDamageModifiedMises3DLaw
 
class  IsotropicDamageModifiedMisesPlaneStrain2DLaw
 
class  IsotropicDamageModifiedMisesPlaneStress2DLaw
 
class  IsotropicDamageSimoJu3DLaw
 
class  IsotropicDamageSimoJuPlaneStrain2DLaw
 
class  IsotropicDamageSimoJuPlaneStress2DLaw
 
class  LinearElasticOrthotropic3DLaw
 
class  LinearElasticPlasticPlaneStrain2DLaw
 
class  LinearElasticPlasticPlaneStress2DLaw
 
class  BeamElement
 Beam Element for 2D and 3D space dimensions. More...
 
class  GeometricallyExactRodElement
 Beam Element for 3D space dimension Romero Displacement-Rotation Geometrically Exact Rod element (based on cross section director vectors) More...
 
class  LargeDisplacementBeamElement
 Beam Element for 3D space dimension Simo Displacement-Rotation Geometrically Exact Rod element. More...
 
class  LargeDisplacementBeamEMCElement
 Beam Element for 3D space dimension. More...
 
class  LargeDisplacementBeamSEMCElement
 Beam Element for 3D space dimension. More...
 
class  SmallDisplacementBeamElement
 Small displacements beam element for 2D and 3D space. More...
 
class  SmallDisplacementBeamElement3D2N
 Beam Element for 3D space dimension. More...
 
class  ShellThickElement3D4N
 ShellThickElement3D4N. More...
 
class  ShellThinElement3D3N
 ShellThinElement3D3N. More...
 
class  AxisymmetricSmallDisplacementElement
 Axisymmetric Small Displacements Element for 2D geometries. More...
 
class  AxisymmetricUpdatedLagrangianElement
 Axisymmetric Updated Lagrangian Element 2D geometries. More...
 
class  AxisymmetricUpdatedLagrangianUPElement
 Axisymmetric Updated Lagrangian U-P Element for 2D geometries. For Linear Triangles. More...
 
class  LargeDisplacementElement
 Large Displacement Lagrangian Element for 3D and 2D geometries. (base class) More...
 
class  LargeDisplacementSegregatedVPElement
 Large Displacement Lagrangian V Element for 3D and 2D geometries. More...
 
class  LargeDisplacementUPElement
 Large Displacement Lagrangian U-P Element for 3D and 2D geometries. Linear Triangles and Tetrahedra (base class) More...
 
class  LargeDisplacementVElement
 Large Displacement Lagrangian V Element for 3D and 2D geometries. More...
 
class  LinearSolidElement
 Linear Solid Element for 3D and 2D geometries. (Template for learning element design) More...
 
class  SmallDisplacementBbarElement
 Small Displacement Bbar Element for 3D and 2D geometries. More...
 
class  TotalLagrangianElement
 Total Lagrangian Element for 3D and 2D geometries. More...
 
class  UpdatedLagrangianSegregatedVPElement
 Updated Lagrangian Segregated Solid Element for 3D and 2D geometries. More...
 
class  UpdatedLagrangianUPElement
 Spatial Lagrangian U-P Element for 3D and 2D geometries. Linear Triangles and Tetrahedra. More...
 
class  UpdatedLagrangianVElement
 Updated Lagrangian Element for 3D and 2D geometries. More...
 
class  AxisymmetricThermalElement
 
class  ThermalElement
 
class  AddDofsProcess
 The base class for fixing scalar variable Dof or array_1d component Dof processes in Kratos. More...
 
class  AssignFlagsToModelPartEntitiesProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  AssignRotationAboutAnAxisToNodesProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  AssignRotationFieldAboutAnAxisToNodesProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  AssignTorqueAboutAnAxisToConditionsProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  AssignTorqueFieldAboutAnAxisToConditionsProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  BuildStringSkinProcess
 
class  ManageTimeStepProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  SolverProcess
 The base class for processes passed to the solution scheme. More...
 
class  TimeDiscretizationProcessTimeDiscretizationProcess
 Short class definition. More...
 
class  TransferSolvingModelPartEntitiesProcess
 Process to transfer model part entities to a solving submodelpart. More...
 
class  CompositeCriterion
 This convergence criteria checks simultaneously different convergence criteria. More...
 
class  ConvergenceCriterion
 Convergence Criterion base class. More...
 
class  DofsCriterion
 This convergence criteria checks the variable dofs. More...
 
class  ResidualCriterion
 This convergence criteria checks the residual. More...
 
class  BlockBuilderAndSolver
 Solution Buider and Solver based on block matrix. More...
 
class  ExplicitBuilderAndSolver
 Explicit Solution Buider and Solver base class. More...
 
class  ExplicitHamiltonBuilderAndSolver
 
class  ReductionBuilderAndSolver
 
class  SolutionBuilderAndSolver
 Solution Buider and Solver base class. More...
 
class  SolverLocalFlags
 Solver local flags class definition. More...
 
class  CriterionLocalFlags
 Solver local flags class definition. More...
 
class  TimeIntegrationLocalFlags
 Solver local flags class definition. More...
 
class  DynamicScheme
 Dynamic integration scheme. More...
 
class  EigensolverScheme
 An adapter scheme for obtaining mass and stiffness matrices for dynamic eigenvalue problems. More...
 
class  ExplicitCentralDifferencesScheme
 An explicit central difference scheme. More...
 
class  ExplicitHamiltonScheme
 
class  SolutionScheme
 Solution scheme base class. More...
 
class  StaticScheme
 Static integration scheme (for static problems) More...
 
class  EigensolverStrategy
 Strategy for solving generalized eigenvalue problems. More...
 
class  ExplicitHamiltonStrategy
 
class  ExplicitSolutionStrategy
 
class  LineSearchSolutionStrategy
 
class  LinearStrategy
 This is the base linear strategy jacobi / gauss-seidel linear strategies. More...
 
class  NewtonRaphsonStrategy
 This is the base Newton Raphson strategy. More...
 
class  SegregatedStrategy
 This is the base class for a segregated strategy for the same model part. More...
 
class  SolutionStrategy
 Solution strategy base class. More...
 
class  BackwardEulerMethod
 Short class definition. More...
 
class  BdfMethod
 Short class definition. More...
 
class  BossakMethod
 Short class definition. More...
 
class  BossakStepMethod
 Short class definition. More...
 
class  BossakStepRotationMethod
 Short class definition. More...
 
class  EmcStepMethod
 Short class definition. More...
 
class  EmcStepRotationMethod
 Short class definition. More...
 
class  NewmarkMethod
 Short class definition. More...
 
class  NewmarkStepMethod
 Short class definition. More...
 
class  NewmarkStepRotationMethod
 Short class definition. More...
 
class  SimoMethod
 Short class definition. More...
 
class  SimoStepMethod
 Short class definition. More...
 
class  SimoStepRotationMethod
 Short class definition. More...
 
class  StaticMethod
 Short class definition. More...
 
class  StaticStepMethod
 Short class definition. More...
 
class  StaticStepRotationMethod
 Short class definition. More...
 
class  TimeIntegrationMethod
 Short class definition. More...
 
class  TimeIntegrationMethodsContainer
 
class  EICR
 EICR Element Independent CoRotational formulation. More...
 
class  EigenvectorToSolutionStepVariableTransferUtility
 Transfer eigenvectors to solution step variables for GiD output or solution initialization. More...
 
class  EnergyUtilities
 Short class definition. More...
 
class  ShellCrossSection
 ShellCrossSection. More...
 
class  ShellQ4_CoordinateTransformation
 ShellQ4_CoordinateTransformation. More...
 
class  ShellQ4_CorotationalCoordinateTransformation
 EICR ShellQ4_CorotationalCoordinateTransformation. More...
 
class  ShellQ4_LocalCoordinateSystem
 ShellQ4_LocalCoordinateSystem. More...
 
class  ShellT3_CoordinateTransformation
 ShellT3_CoordinateTransformation. More...
 
class  ShellT3_CorotationalCoordinateTransformation
 EICR ShellT3_CorotationalCoordinateTransformation. More...
 
class  ShellT3_LocalCoordinateSystem
 ShellT3_LocalCoordinateSystem. More...
 
class  KratosSolidMechanicsApplication
 Short class definition. More...
 
class  KratosStatisticsApplication
 Short class definition. More...
 
class  AxisymLineLoadCondition2D
 Axisymmetric line load condition. More...
 
class  AxisymPointLoadCondition
 Axisymmetric point load condition. More...
 
class  BaseLoadCondition
 This is the base class of all the load conditions on StructuralMechanicsApplication. More...
 
class  DisplacementControlCondition
 This class is to add contributions to LHS and RHS of the displacement control condition. More...
 
class  MovingLoadCondition
 This class is the responsible to add the contributions of the RHS and LHS of the moving loads of the structure. More...
 
class  PointContactCondition
 Short class definition. More...
 
class  PointMomentCondition3D
 
class  SmallDisplacementLineLoadCondition
 This class is the responsible to add the contributions of the RHS and LHS of the line loads of the structure. More...
 
class  SmallDisplacementSurfaceLoadCondition3D
 This class is the responsible to add the contributions of the RHS and LHS of the surface loads of the structure. More...
 
class  SurfaceLoadCondition3D
 This class is the responsible to add the contributions of the RHS and LHS of the surface loads of the structure. More...
 
class  AxisymElasticIsotropic
 
class  BeamConstitutiveLaw
 
class  ElasticIsotropic3D
 
class  LinearPlaneStrain
 This class defines a small deformation linear elastic constitutive model for 3D cases. More...
 
class  LinearPlaneStress
 This class defines a small deformation linear elastic constitutive model for plane stress cases. More...
 
class  TrussConstitutiveLaw
 
class  UserProvidedLinearElasticLaw
 This class defines a linear elastic law with user provided constitutive tensor. More...
 
class  AxisymSmallDisplacement
 Axisymmetric Kinematic Linear element. More...
 
class  AxisymTotalLagrangian
 Axisymmetric Total Lagrangian element. More...
 
class  AxisymUpdatedLagrangian
 Axisymmetric Updated Lagrangian element. More...
 
class  BaseShellElement
 
class  CableElement3D2N
 This is a 3D-2node cable element with 3 translational dofs per node inheriting from the TrussElement3D2N. More...
 
class  CrBeamElement2D2N
 This is a 2D-2node beam element with 2 translational dofs and 1 rotational dof per node. More...
 
class  CrBeamElement3D2N
 This is a 3D-2node beam element with 3 translational dofs and 3 rotational dof per node. More...
 
class  CrBeamElementLinear2D2N
 This is a linear 2D-2node beam element with 2 translational dofs and 1 rotational dof per node inheriting from CrBeamElement2D2N. More...
 
class  CrBeamElementLinear3D2N
 This is a linear 3D-2node beam element with 3 translational dofs and 3 rotational dof per node inheriting from CrBeamElement3D2N. More...
 
class  IsotropicShellElement
 Short class definition. More...
 
class  MassElement
 
class  MembraneElement
 
class  NodalConcentratedElement
 Concentrated nodal for 3D and 2D points. More...
 
class  ShellThickElement3D3N
 ShellThickElement3D3N. More...
 
class  ShellThinElement3D4N
 ShellThinElement3D4N. More...
 
class  SmallDisplacement
 Small displacement element for 2D and 3D geometries. More...
 
class  SmallDisplacementBbar
 Infinitesimal strain definition with mixed B-bar formulation. More...
 
class  SmallDisplacementMixedVolumetricStrainElement
 Small displacement with strain based mixed formulation element. More...
 
class  SolidShellElementSprism3D6N
 This is a triangular prism solid element for the analysis of thin/thick shells undergoing large elastic–plastic strains. More...
 
class  SpringDamperElement
 Concentrated nodal for 3D and 2D points. More...
 
class  TotalLagrangian
 Total Lagrangian element for 2D and 3D geometries. More...
 
class  TotalLagrangianMixedVolumetricStrainElement
 Total Lagrangian mixed displacement volumetric strain formulation element. More...
 
class  TotalLagrangianQ1P0MixedElement
 Total Lagrangian mixed u-p element (Q1P0) for 2D and 3D geometries. More...
 
class  TrussElement3D2N
 This is a 3D-2node truss element with 3 translational dofs per node. More...
 
class  TrussElementLinear3D2N
 This is a linear 3D-2node truss element with 3 translational dofs per node inheriting from TrussElement3D2N. More...
 
class  UpdatedLagrangian
 Updated Lagrangian element for 2D and 3D geometries. More...
 
class  ZStrainDriven2p5DSmallDisplacement
 Small displacement element for 2.5D cases. More...
 
class  GidEigenIO
 GidIO extended for writting Eigenvalue Results. More...
 
class  VtkEigenOutput
 VtkEigenOutput A simple class to write Eigenresults in Vtk format. More...
 
class  ComputeCenterOfGravityProcess
 This method computes the center of gravity. More...
 
class  ComputeMassMomentOfInertiaProcess
 This method computes the moment of inertia (rotational) More...
 
class  DistributeLoadOnSurfaceProcess
 This process distributes a load on surface load conditions belonging to a modelpart. More...
 
class  ImposeRigidMovementProcess
 This method assign linear kinematic constrains to a certain submodelpart. More...
 
class  ImposeZStrainProcess
 This class assigns the same Z-Strain value to the member variables of all 2.5D solid elements. More...
 
class  PostprocessEigenvaluesProcess
 Process to create the animated Eigenvectors. More...
 
class  PrismNeighboursProcess
 An algorithm that looks for neighbour nodes and elements in a mesh of prismatic elements. More...
 
class  SetAutomatedInitialVariableProcess
 This class automotes the creation of the variables INITIAL_STRAIN_VECTOR and INITIAL_STRESS_VECTOR using tables imported from csv files. More...
 
class  SetCartesianLocalAxesProcess
 This class set the local axes of the elements according to a given set of cartesian axes. More...
 
class  SetCylindricalLocalAxesProcess
 This class set the local axes of the elements according to a cylindrical coordinates. More...
 
class  SetMovingLoadProcess
 Process to set the moving load. More...
 
class  SetSphericalLocalAxesProcess
 This class set the local axes of the elements according to a SPHERICAL coordinates. More...
 
class  ShellToSolidShellProcess
 This method transforms triangular and quadrilateral elements into prisms and hexahedra elements. More...
 
class  SolidShellThickComputeProcess
 This method computes the current thickness in a node of a solid-shell. More...
 
class  SPRErrorProcess
 This class is can be used to compute the metrics of the model part with a superconvergent patch recovery (SPR) approach. More...
 
class  TotalStructuralMassProcess
 This method computes the total mass of a structure. More...
 
class  AdjointSemiAnalyticBaseCondition
 AdjointSemiAnalyticBaseCondition. More...
 
class  AdjointSemiAnalyticPointLoadCondition
 
class  AdjointFiniteDifferencingBaseElement
 AdjointFiniteDifferencingBaseElement. More...
 
class  AdjointFiniteDifferenceCrBeamElement
 
class  AdjointFiniteDifferencingShellElement
 AdjointFiniteDifferencingShellElement. More...
 
class  AdjointFiniteDifferencingSmallDisplacementElement
 AdjointFiniteDifferencingSmallDisplacementElement. More...
 
class  AdjointFiniteDifferenceSpringDamperElement
 AdjointFiniteDifferenceSpringDamperElement. More...
 
class  AdjointFiniteDifferenceTrussElement
 AdjointFiniteDifferencingBaseElement. More...
 
class  AdjointFiniteDifferenceTrussElementLinear
 AdjointFiniteDifferencingBaseElement. More...
 
class  AdjointSolidElement
 A template class for creating adjoint elements for solids. More...
 
class  ReplaceMultipleElementsAndConditionsProcess
 This methods replaces elements and conditions in a model part by a given table. More...
 
class  AdjointLinearStrainEnergyResponseFunction
 AdjointLinearStrainEnergyResponseFunction. More...
 
class  AdjointLocalStressResponseFunction
 AdjointLocalStressResponseFunction. More...
 
class  AdjointMaxStressResponseFunction
 AdjointMaxStressResponseFunction. More...
 
class  AdjointNodalDisplacementResponseFunction
 AdjointNodalDisplacementResponseFunction. More...
 
class  AdjointNodalReactionResponseFunction
 AdjointNodalReactionResponseFunction. More...
 
class  AdjointStructuralResponseFunction
 AdjointStructuralResponseFunction. More...
 
class  EigenfrequencyResponseFunctionUtility
 Short class definition. More...
 
class  FiniteDifferenceUtility
 FiniteDifferenceUtility. More...
 
class  MassResponseFunctionUtility
 Short class definition. More...
 
class  StrainEnergyResponseFunctionUtility
 Short class definition. More...
 
class  StressCalculation
 StressCalculation. More...
 
class  ErrorMeshCriteria
 Custom convergence for used to check the convergence in the mesh error. More...
 
class  ResidualDisplacementAndOtherDoFCriteria
 This is a convergence criteria that employes the residual as criteria, it divides the problem in two dofs, displacement and another one. More...
 
class  EigensolverDynamicScheme
 An adapter scheme for obtaining mass and stiffness matrices for dynamic eigenvalue problems. More...
 
class  ExplicitMultiStageKimScheme
 An explicit multi stage scheme. More...
 
class  ResidualBasedRelaxationScheme
 
class  FormfindingStrategy
 
class  HarmonicAnalysisStrategy
 Strategy for solving generalized eigenvalue problems. More...
 
class  MechanicalExplicitStrategy
 This strategy is used for the explicit time integration. More...
 
class  PrebucklingStrategy
 Strategy for linearized prebuckling analysis. More...
 
class  NodeConfigureForNodeSearch
 Configuration file for nodes. More...
 
class  NodeSearchUtility
 Node Search. More...
 
class  PerturbGeometryBaseUtility
 Base class for geometry perturbation utilities. More...
 
class  PerturbGeometrySparseUtility
 This class generates a random field based on a sparse correlation matrix. More...
 
class  PerturbGeometrySubgridUtility
 This class generates a random field based on a reduced correlation matrix. More...
 
class  ProjectVectorOnSurfaceUtility
 Short class definition. More...
 
class  StructuralMechanicsMathUtilities
 
class  KratosStructuralMechanicsApplication
 This application features Elements, Conditions, Constitutive laws and Utilities for structural analysis problems. More...
 
class  ComputeLaplacianSimplexCondition
 Implements a wall condition for the laplacian recovery. More...
 
class  MonolithicDEMCoupledWallCondition
 Implements a wall condition for the monolithic formulation. More...
 
class  ArchimedesBuoyancyLaw
 
class  BuoyancyLaw
 
class  BeetstraDragLaw
 
class  ChienDragLaw
 
class  DallavalleDragLaw
 
class  DragLaw
 
class  GanserDragLaw
 
class  HaiderAndLevenspielDragLaw
 
class  NewtonDragLaw
 
class  SchillerAndNaumannDragLaw
 
class  ShahDragLaw
 
class  StokesDragLaw
 
class  BoussinesqBassetHistoryForceLaw
 
class  HistoryForceLaw
 
class  HydrodynamicInteractionLaw
 
class  AutonHuntPrudhommeInviscidForceLaw
 
class  InviscidForceLaw
 
class  ZuberInviscidForceLaw
 
class  PowerLawFluidHydrodynamicInteractionLaw
 
class  LothRotationInducedLiftLaw
 
class  OesterleAndDinhLiftLaw
 
class  RotationInducedLiftLaw
 
class  RubinowAndKellerLiftLaw
 
class  LothSteadyViscousTorqueLaw
 
class  RubinowAndKellerTorqueLaw
 
class  SteadyViscousTorqueLaw
 
class  ElSamniLiftLaw
 
class  MeiLiftLaw
 
class  SaffmanLiftLaw
 
class  VorticityInducedLiftLaw
 
class  ComputeComponentGradientSimplex
 A post-processing element to recover the Laplacian from the velocity solution. More...
 
class  ComputeGradientPouliot2012
 A post-processing element to recover the Laplacian from the velocity solution. More...
 
class  ComputeGradientPouliot2012Edge
 A post-processing element to recover the Laplacian from the velocity solution. More...
 
class  ComputeLaplacianSimplex
 A post-processing element to recover the Laplacian from the velocity solution. More...
 
class  ComputeMaterialDerivativeSimplex
 A post-processing element to recover the Laplacian from the velocity solution. More...
 
class  ComputeVelocityLaplacianSimplex
 A post-processing element to recover the Laplacian from the velocity solution. More...
 
class  ComputeVelocityLaplacianComponentSimplex
 A post-processing element to recover the Laplacian from the velocity solution. More...
 
class  MonolithicDEMCoupled
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  MonolithicDEMCoupledWeak
 A stabilized element for the incompressible Navier-Stokes equations. More...
 
class  ShellRigid
 Short class definition. More...
 
class  SwimmingParticle
 
class  ApplyRigidRotationProcess
 Process used to rotate eulerian model parts using Rodrigues' rotation formula. More...
 
class  BumpTransientPorositySolutionBodyForceProcess
 
class  HyperbolicTangentialPorositySolutionAndBodyForceProcess
 
class  HyperbolicTangentialPorositySolutionTransientBodyForceProcess
 
class  PorositySolutionAndBodyForceProcess
 
class  PorositySolutionAndSinusoidalBodyForceProcess
 
class  PorositySolutionTransientBodyForceProcess
 
class  SinusoidalPorositySolutionAndBodyForceProcess
 
class  SinusoidalPorositySolutionTransientBodyForceProcess
 
class  HybridBashforthScheme
 
class  SymplecticEulerOldVelocityScheme
 
class  TerminalVelocityScheme
 
class  AdamsBashforthStrategy
 
class  BDF2TurbulentSchemeDEMCoupled
 A scheme for BDF2 time integration. More...
 
class  RelaxedResidualBasedNewtonRaphsonStrategy
 This is the base Newton Raphson strategy. More...
 
class  ResidualBasedDerivativeRecoveryStrategy
 Short class definition. More...
 
class  ResidualBasedPredictorCorrectorVelocityBossakSchemeTurbulentDEMCoupled
 
class  BassetForceTools
 
class  BinBasedDEMFluidCoupledMapping
 
class  CustomFunctionsCalculator
 
class  DerivativeRecovery
 This class constructs nodal approximations of the derivatives of a field given a Lagrangian linear FEM approximation of it. More...
 
class  DerivativeRecoveryMeshingTools
 This class performs simple meshing tools related to the derivative recovery algorithms. More...
 
class  EmbeddedVolumeTool
 
class  CellularFlowField
 
class  CellularFlowPartialDerivatives
 
class  CodinaManufacturedField
 
class  ConstantVelocityField
 
class  EthierFlowField
 
class  FieldUtility
 
class  FluidFieldUtility
 
class  PouliotFlowField
 
class  PouliotFlowField2D
 
class  ProductOfSines
 
class  RealField
 
class  LinearRealField
 
class  RealFunction
 
class  LinearFunction
 
class  PowerFunction
 
class  AdditionFunction
 
class  ProductFunction
 
class  CompositionFunction
 
class  SpaceTimeRule
 
class  BoundingBoxRule
 
class  MoreThanRule
 
class  EqualToRule
 
class  SpaceTimeSet
 
class  ShearFlow1DWithExponentialViscosityField
 
class  TimeDependant1DPorosityField
 
class  TimeDependantForceField
 
class  TimeDependantPorosityField
 
class  VectorField
 
class  VelocityField
 
class  Bentonite_Force_Based_Inlet
 
class  L2ErrorNormCalculator
 
class  MeshRotationUtility
 
class  DensityFunction
 
class  DensityFunctionNormal
 
class  DensityFunctionPolynomial
 
class  Mollifier
 
class  PorosityUtils
 
class  MpiDiscreteParticleConfigure
 
class  Mpi_Neighbours_Calculator
 
class  PointConfigure
 
class  PointPointSearch
 Short class definition. More...
 
class  FlowStationarityCheck
 This defines a class to assess whether stationarity has been reached in the fluid. More...
 
class  SamplingTool
 
class  SwimmingDemInPfemUtils
 
class  VolumeAveragingTool
 This class is designed to manage the volume averaging of DEM properties and their projection onto a mesh. More...
 
class  KratosSwimmingDEMApplication
 
class  DirectConductionBOBComplete
 
class  DirectConductionBOBModified
 
class  DirectConductionBOBSimple
 
class  DirectConductionCollision
 
class  DirectConductionModel
 
class  DirectConductionPipe
 
class  IndirectConductionModel
 
class  IndirectConductionSurroundLayer
 
class  IndirectConductionVargas
 
class  IndirectConductionVoronoiA
 
class  IndirectConductionVoronoiB
 
class  ConvectionModel
 
class  NusseltGunn
 
class  NusseltHanzMarshall
 
class  NusseltLiMason
 
class  NusseltWhitaker
 
class  GenerationDissipation
 
class  GenerationModel
 
class  HeatExchangeMechanism
 
class  HeatGenerationMechanism
 
class  RadiationContinuumKrause
 
class  RadiationContinuumZhou
 
class  RadiationModel
 
class  RealContactLu
 
class  RealContactModel
 
class  RealContactMorris
 
class  RealContactZhou
 
class  SinteringContinuum
 
class  SinteringSphericContinuumParticle
 
class  ThermalSphericContinuumParticle
 
class  ThermalSphericParticle
 
class  ThermalDEMIntegrationScheme
 
class  ThermalForwardEulerScheme
 
class  ThermalExplicitSolverStrategy
 
class  GraphUtilities
 
class  HeatMapUtilities
 
class  AdaptiveSimpsonQuadrature
 
class  NumericalIntegrationMethod
 
class  SetThermalDataUtilities
 
class  TesselationUtilities2D
 
class  TesselationUtilities3D
 
class  KratosThermalDEMApplication
 
class  DEMThermalFlags
 
class  SmallDisplacementSIMPElement
 Topology Optimization Small Displacement Element for 3D geometries. More...
 
class  ResidualBasedIncrementalUpdateStaticSIMPScheme
 
class  StructureAdjointSensitivityStrategy
 
class  IOUtilities
 Solution utility to filter results. More...
 
class  StructureResponseFunctionUtilities
 Solution utility to compute structural analysis responses. More...
 
class  TopologyFilteringUtilities
 Solution utility to filter results. More...
 
class  TopologyUpdatingUtilities
 Solution utility that updates response values for next iteration. More...
 
class  KratosTopologyOptimizationApplication
 Short class definition. More...
 
class  TrilinosLinearSolverFactory
 Here we add the functions needed for the registration of linear solvers. More...
 
class  TrilinosLevelSetConvectionProcess
 Short class definition. More...
 
class  AuxiliaryMatrixWrapper
 Auxiliarty Trilinos matrix pointer wrapper class. More...
 
class  AuxiliaryVectorWrapper
 Auxiliarty Trilinos vector pointer wrapper class. More...
 
class  TrilinosBlockBuilderAndSolver
 Current class provides an implementation for trilinos builder and solving operations. More...
 
class  TrilinosBlockBuilderAndSolverPeriodic
 
class  TrilinosResidualBasedEliminationBuilderAndSolver
 
class  TrilinosDisplacementCriteria
 MPI version of the DisplacementCriteria. More...
 
class  TrilinosMixedGenericCriteria
 Convergence criteria for mixed vector-scalar problems. More...
 
class  TrilinosResidualCriteria
 MPI version of the ResidualCriteria. More...
 
class  TrilinosResidualBasedIncrementalAitkenStaticScheme
 A scheme for the solution of a problem using Aitken iterations. More...
 
class  TrilinosAssemblingUtilities
 The Trilinos assembling utilities. More...
 
class  TrilinosCuttingApplication
 TRILINOS CUTTING APPLICATION. More...
 
class  TrilinosCuttingIsosurfaceApplication
 
class  TrilinosDofUpdater
 Utility class to update the values of degree of freedom (Dof) variables after solving the system. More...
 
class  TrilinosJacobianEmulator
 Jacobian emulator. More...
 
class  TrilinosMVQNRecursiveJacobianConvergenceAccelerator
 MVQN (MultiVectorQuasiNewton method) acceleration scheme Recursive MultiVectorQuasiNewton convergence accelerator. This convergence accelerator is an alternative implementation of the standard MVQN that avoids the storage of the. More...
 
class  TrilinosPartitionedFSIUtilities
 Trilinos version of the partitioned FSI tools. More...
 
class  TrilinosRefineMesh
 
class  Amesos2Solver
 Wrapper for Trilinos-Amesos2 Direct Solvers. More...
 
class  AmesosSolver
 Wrapper for Trilinos-Amesos Direct Solvers. More...
 
class  AmgclMPISchurComplementSolver
 
class  AmgclMPISolver
 This is a multigrid solver based on the AMGCL library. More...
 
class  AztecSolver
 Wrapper for Trilinos-Aztec Iterative Solvers. More...
 
class  MultiLevelSolver
 Wrapper for Trilinos-ML preconditioner using the Aztec-Solver. More...
 
class  TrilinosMonotonicityPreservingSolver
 
class  KratosTrilinosApplication
 Short class definition. More...
 
class  TrilinosSpace
 The space adapted for Trilinos vectors and matrices. More...
 
class  PointNeumann2D
 Short class definition. More...
 
class  PointNeumann3D
 Short class definition. More...
 
class  PointNeumannAxisym
 Short class definition. More...
 
class  Fluid2DGLS_expl
 Short class definition. More...
 
class  HypoElasticSolid2D
 Short class definition. More...
 
class  SurfaceTension
 A stabilized element for the incompressible Navier-Stokes equations, utilizing lagrangian_Eulerian approach for droplet dynamics. More...
 
class  UlfAxisym
 Short class definition. More...
 
class  UlfFrac2D
 Short class definition. More...
 
class  UlfFrac3D
 Short class definition. More...
 
class  UpdatedLagrangianFluid
 Short class definition. More...
 
class  UpdatedLagrangianFluid3D
 Short class definition. More...
 
class  UpdatedLagrangianFluid3Dinc
 Short class definition. More...
 
class  UpdatedLagrangianFluidInc
 Short class definition. More...
 
class  AddWallProcess
 Short class definition. More...
 
class  AssignSurfaceTensionConditions
 Short class definition. More...
 
class  CalculateAdhesionForce
 Short class definition. More...
 
class  CalculateContactAngle
 Short class definition. More...
 
class  CalculateCurvature
 Short class definition. More...
 
class  CalculateNodalLength
 Short class definition. More...
 
class  CalculateNormalEq
 Short class definition. More...
 
class  FindNodalNeighboursSurfaceProcess
 Short class definition. More...
 
class  FindTriplePoint
 Short class definition. More...
 
class  HypoelasticStressCalculateProcess
 Short class definition. More...
 
class  LagrangianInletProcess
 Short class definition. More...
 
class  MarkBadElementsProcess
 Short class definition. More...
 
class  MarkCloseNodesProcess
 Short class definition. More...
 
class  MarkFreeSurfaceProcess
 Short class definition. More...
 
class  MassCalculateProcess
 Short class definition. More...
 
class  MergeModelPartsProcess
 Short class definition. More...
 
class  PressureCalculateProcess
 Short class definition. More...
 
class  PressureCalculateProcessAxisym
 Short class definition. More...
 
class  RemoveAndSaveWallNodesProcess
 Short class definition. More...
 
class  SaveFluidOnlyProcess
 Short class definition. More...
 
class  SaveStructureConditionsProcess
 Short class definition. More...
 
class  SaveStructureModelPartProcess
 Short class definition. More...
 
class  UlfTimeStepDecProcess
 Short class definition. More...
 
class  ResidualBasedEliminationQuasiIncompressibleBuilderAndSolver
 
class  ResidualBasedPredictorCorrectorBossakScheme
 
class  LapModifiedLinearStrategy
 Short class definition. More...
 
class  RungeKuttaFracStepStrategy
 Short class definition. More...
 
class  AssignPointNeumannConditions
 
class  NistUtils
 
class  UlfUtils
 
class  KratosULFApplication
 Short class definition. More...
 
class  FabricSmallStrainUmatModel
 Short class definition. More...
 
class  HypoplasticSmallStrainUmatModel
 Short class definition. More...
 
class  LargeStrainUmatModel
 Short class definition. More...
 
class  SmallStrainUmatModel
 Short class definition. More...
 
class  VonMisesLargeStrainUmatModel
 Short class definition. More...
 
class  VonMisesSmallStrainUmatModel
 Short class definition. More...
 
class  KratosUmatApplication
 Short class definition. More...
 
class  KratosWindEngineeringApplication
 

Typedefs

typedef TUblasDenseSpace< doubleLocalSparseSpaceType
 
typedef LinearSolverFactory< SparseSpaceType, LocalSparseSpaceTypeLinearSolverFactoryType
 
typedef TUblasSparseSpace< std::complex< double > > ComplexSparseSpaceType
 
typedef TUblasDenseSpace< std::complex< double > > ComplexLocalSparseSpaceType
 
typedef LinearSolverFactory< ComplexSparseSpaceType, ComplexLocalSparseSpaceTypeComplexLinearSolverFactoryType
 
typedef MapperDefinitions::DenseSpaceType DenseSpaceType
 
typedef PreconditionerFactory< SparseSpaceType, LocalSparseSpaceTypePreconditionerFactoryType
 
typedef DenseVector< array_1d< double, 3 > > VectorArray3Double
 
typedef GeometryData::IntegrationMethod IntegrationMethodType
 
typedef GeometryData::KratosGeometryFamily KratosGeometryFamily
 
template<class T >
using shared_ptr = std::shared_ptr< T >
 
template<class T >
using weak_ptr = std::weak_ptr< T >
 
template<class T >
using unique_ptr = std::unique_ptr< T >
 
using RealSparseSpace = UblasSpace< double, boost::numeric::ublas::compressed_matrix< double >, boost::numeric::ublas::vector< double > >
 
using RealDenseSpace = UblasSpace< double, DenseMatrix< double >, DenseVector< double > >
 
using ComplexSparseSpace = UblasSpace< std::complex< double >, boost::numeric::ublas::compressed_matrix< std::complex< double > >, boost::numeric::ublas::vector< std::complex< double > >>
 
using ComplexDenseSpace = UblasSpace< std::complex< double >, DenseMatrix< std::complex< double > >, DenseVector< std::complex< double > >>
 
typedef DiscreteParticleConfigure< 3 > DiscreteParticleConfigure3D
 
typedef ModelPart::ConditionsContainerType::iterator ConditionsIteratorType
 
typedef AnalyticRigidFace3D AnalyticFace
 
typedef ModelPart::ElementsContainerType::iterator ElementsIteratorType
 
typedef Kratos::AnalyticSphericParticle AnalyticParticle
 
typedef ModelPart::NodesContainerType::iterator NodeIteratorType
 
typedef ModelPart::ElementsContainerType::iterator ElementIteratorType
 
typedef Properties PropertiesType
 
typedef Mesh< NodeType, PropertiesType, ElementType, ConditionTypeMeshType
 
typedef PointerVector< MeshTypeMeshesContainerType
 
typedef MeshType::ElementIterator ElementIterator
 
typedef LinearSolver< SparseSpaceType, LocalSpaceTypeLinearSolverType
 
template<class TSparseSpace , class TDenseSpace >
using CompressibleNavierStokesExplicitSolvingStrategyForwardEuler = CompressibleNavierStokesExplicitSolvingStrategyRungeKutta< TSparseSpace, TDenseSpace, ButcherTableauForwardEuler >
 
template<class TSparseSpace , class TDenseSpace >
using CompressibleNavierStokesExplicitSolvingStrategyRungeKutta4 = CompressibleNavierStokesExplicitSolvingStrategyRungeKutta< TSparseSpace, TDenseSpace, ButcherTableauRK4 >
 
template<class TSparseSpace , class TDenseSpace >
using CompressibleNavierStokesExplicitSolvingStrategyRungeKutta3TVD = CompressibleNavierStokesExplicitSolvingStrategyRungeKutta< TSparseSpace, TDenseSpace, ButcherTableauRK3TVD >
 
typedef void(* pF_GetParamCount) (int *, int *)
 
typedef void(* pF_GetStateVarCount) (int *, int *)
 
typedef void(* pF_UserMod) (int *, int *, int *, int *, int *, int *, int *, double *, double *, double *, double *, double *, const double *, double *, double *, double *, double *, double **, double *, double *, double *, double *, int *, int *, int *, int *, int *, int *, int *, int *, int *)
 
typedef void(* pF_UMATMod) (double *STRESS, double *STATEV, double **DDSDDE, double *SSE, double *SPD, double *SCD, double *rpl, double *ddsddt, double *drplde, double *drpldt, double *stran, double *dstran, double *time, double *dtime, double *temp, double *dtemp, double *predef, double *dpred, char *materl, int *ndi, int *nshr, int *ntens, int *nstatv, const double *props, int *nprops, double *coords, double **drot, double *pnewdt, double *celent, double **dfgrd0, double **dfgrd1, int *noel, int *npt, double *kslay, double *kspt, int *kstep, int *kinc)
 
typedef LinearSolverFactory< LocalSparseSpaceType, LocalSparseSpaceTypeDenseLinearSolverFactoryType
 
typedef LinearSolverFactory< ComplexLocalSparseSpaceType, ComplexLocalSparseSpaceTypeComplexDenseLinearSolverFactoryType
 
template<typename _Scalar >
using EigenDynamicMatrix = Eigen::Matrix< _Scalar, Eigen::Dynamic, Eigen::Dynamic, Eigen::RowMajor >
 
template<typename _Scalar >
using EigenDynamicVector = Eigen::Matrix< _Scalar, Eigen::Dynamic, 1 >
 
template<typename _Scalar >
using EigenSparseMatrix = Eigen::SparseMatrix< _Scalar, Eigen::RowMajor, int >
 
typedef InterfaceVectorContainer< SparseSpaceType, DenseSpaceTypeVectorContainerType
 
typedef boost::geometry::model::point< double, 2, boost::geometry::cs::cartesian > Boost2DPointType
 
typedef boost::geometry::model::polygon< Boost2DPointTypeBoost2DPolygonType
 
typedef Geometry< Node >::Pointer GeometryNodePointerType
 
typedef PointerVector< PFEM_Particle, PFEM_Particle *, std::vector< PFEM_Particle * > > ParticlePointerVector
 
typedef PointerVector< PFEM_Particle_Fluid, PFEM_Particle_Fluid *, std::vector< PFEM_Particle_Fluid * > > FluidParticlePointerVector
 
typedef PointerVectorSet< Properties, IndexedObjectPropertiesContainerType
 
typedef PropertiesContainerType::Pointer PropertiesContainerPointerType
 
typedef Scheme< SparseSpaceType, LocalSpaceTypeBaseSchemeType
 
typedef UblasSpace< double, Matrix, VectorTrilinosLocalSpaceType
 
typedef LinearSolverFactory< TrilinosSparseSpaceType, TrilinosLocalSpaceTypeTrilinosLinearSolverFactoryType
 

Enumerations

enum  MeshType { Local , Ghost , Interface }
 
enum class  SofteningType { Linear = 0 , Exponential = 1 , HardeningDamage = 2 , CurveFittingDamage = 3 }
 
enum class  TangentOperatorEstimation {
  Analytic = 0 , FirstOrderPerturbation = 1 , SecondOrderPerturbation = 2 , Secant = 3 ,
  SecondOrderPerturbationV2 = 4 , InitialStiffness = 5
}
 
enum  indexDOF3D : int { INDEX_X , INDEX_Y , INDEX_Z }
 
enum  indexStress3D : int {
  INDEX_3D_XX , INDEX_3D_YY , INDEX_3D_ZZ , INDEX_3D_XY ,
  INDEX_3D_YZ , INDEX_3D_XZ
}
 
enum  indexStress2DPlaneStrain : int { INDEX_2D_PLANE_STRAIN_XX , INDEX_2D_PLANE_STRAIN_YY , INDEX_2D_PLANE_STRAIN_ZZ , INDEX_2D_PLANE_STRAIN_XY }
 
enum  indexStress2DPlaneStress : int { INDEX_2D_PLANE_STRESS_XX , INDEX_2D_PLANE_STRESS_YY , INDEX_2D_PLANE_STRESS_XY }
 
enum  indexStress2DAxisymmetric : int { INDEX_2D_AXI_SYMMETRIC_XX , INDEX_2D_AXI_SYMMETRIC_YY , INDEX_2D_AXI_SYMMETRIC_RR , INDEX_2D_AXI_SYMMETRIC_XY }
 
enum  indexStress2DInterface : int { INDEX_2D_INTERFACE_XZ , INDEX_2D_INTERFACE_ZZ }
 
enum  indexStress3DInterface : int { INDEX_3D_INTERFACE_XZ , INDEX_3D_INTERFACE_YZ , INDEX_3D_INTERFACE_ZZ }
 
enum  indexStress2DBeam : int { INDEX_2D_BEAM_XX , INDEX_2D_BEAM_YY , INDEX_2D_BEAM_XY }
 
enum  indexDOF2DBeam : int { INDEX_2D_BEAM_X , INDEX_2D_BEAM_Y , INDEX_2D_BEAM_T }
 
enum class  indexThermalFlux : int { X , Y , Z }
 
enum class  TracedStressType {
  FX , FY , FZ , MX ,
  MY , MZ , FXX , FXY ,
  FXZ , FYX , FYY , FYZ ,
  FZX , FZY , FZZ , MXX ,
  MXY , MXZ , MYX , MYY ,
  MYZ , MZX , MZY , MZZ ,
  PK2 , VON_MISES_STRESS
}
 
enum class  StressTreatment { Mean , Node , GaussPoint }
 
Enum's
enum class  OBBHasIntersectionType { Direct = 0 , SeparatingAxisTheorem = 1 }
 This enum defines the different types of checks that can be done for the HasIntersection: More...
 
enum  WriteDeformedMeshFlag { WriteDeformed , WriteUndeformed }
 Flags for mesh writing. More...
 
enum  WriteConditionsFlag { WriteConditions , WriteElementsOnly , WriteConditionsOnly }
 
enum  MultiFileFlag { SingleFile , MultipleFiles }
 
enum class  PointBelongs { Master = 0 , Slave = 1 , Intersection = 2 }
 This enum defines a "hash" used to identify in which combination of cuts the point is found when the mortar segmentation is performed. More...
 
enum class  PointBelongsLine2D2N {
  SlaveLine2D2N0 = 0 , SlaveLine2D2N1 = 1 , MasterLine2D2N0 = 2 , MasterLine2D2N1 = 3 ,
  IntersectionLine2D2N = 4
}
 Case for 2D line intersected with another 2D line. More...
 
enum class  PointBelongsTriangle3D3N {
  SlaveTriangle3D3N0 = 0 , SlaveTriangle3D3N1 = 1 , SlaveTriangle3D3N2 = 2 , MasterTriangle3D3N0 = 3 ,
  MasterTriangle3D3N1 = 4 , MasterTriangle3D3N2 = 5 , IntersectionTriangle3D3N = 6 , IntersectionTriangle3D3N0101 = 10106 ,
  IntersectionTriangle3D3N1001 = 10016 , IntersectionTriangle3D3N1201 = 10216 , IntersectionTriangle3D3N2101 = 10126 , IntersectionTriangle3D3N0201 = 10206 ,
  IntersectionTriangle3D3N2001 = 10026 , IntersectionTriangle3D3N0110 = 1106 , IntersectionTriangle3D3N1010 = 1016 , IntersectionTriangle3D3N1210 = 1216 ,
  IntersectionTriangle3D3N2110 = 1126 , IntersectionTriangle3D3N0210 = 1206 , IntersectionTriangle3D3N2010 = 1026 , IntersectionTriangle3D3N0112 = 21106 ,
  IntersectionTriangle3D3N1012 = 21016 , IntersectionTriangle3D3N1212 = 21216 , IntersectionTriangle3D3N2112 = 21126 , IntersectionTriangle3D3N0212 = 21206 ,
  IntersectionTriangle3D3N2012 = 21026 , IntersectionTriangle3D3N0121 = 12106 , IntersectionTriangle3D3N1021 = 12016 , IntersectionTriangle3D3N1221 = 12216 ,
  IntersectionTriangle3D3N2121 = 12126 , IntersectionTriangle3D3N0221 = 12206 , IntersectionTriangle3D3N2021 = 12026 , IntersectionTriangle3D3N0102 = 20106 ,
  IntersectionTriangle3D3N1002 = 20016 , IntersectionTriangle3D3N1202 = 20216 , IntersectionTriangle3D3N2102 = 20126 , IntersectionTriangle3D3N0202 = 20206 ,
  IntersectionTriangle3D3N2002 = 20026 , IntersectionTriangle3D3N0120 = 2106 , IntersectionTriangle3D3N1020 = 2016 , IntersectionTriangle3D3N1220 = 2216 ,
  IntersectionTriangle3D3N2120 = 2126 , IntersectionTriangle3D3N0220 = 2206 , IntersectionTriangle3D3N2020 = 2026
}
 Case for 3D triangle intersected with another 3D triangle. More...
 
enum class  PointBelongsQuadrilateral3D4N {
  SlaveQuadrilateral3D4N0 = 0 , SlaveQuadrilateral3D4N1 = 1 , SlaveQuadrilateral3D4N2 = 2 , SlaveQuadrilateral3D4N3 = 3 ,
  MasterQuadrilateral3D4N0 = 4 , MasterQuadrilateral3D4N1 = 5 , MasterQuadrilateral3D4N2 = 6 , MasterQuadrilateral3D4N3 = 7 ,
  IntersectionQuadrilateral3D4N = 8 , IntersectionQuadrilateral3D4N0101 = 10108 , IntersectionQuadrilateral3D4N1001 = 10018 , IntersectionQuadrilateral3D4N1201 = 10218 ,
  IntersectionQuadrilateral3D4N2101 = 10128 , IntersectionQuadrilateral3D4N2301 = 10328 , IntersectionQuadrilateral3D4N3201 = 10238 , IntersectionQuadrilateral3D4N3001 = 10038 ,
  IntersectionQuadrilateral3D4N0301 = 10308 , IntersectionQuadrilateral3D4N0110 = 1108 , IntersectionQuadrilateral3D4N1010 = 1018 , IntersectionQuadrilateral3D4N1210 = 1218 ,
  IntersectionQuadrilateral3D4N2110 = 1128 , IntersectionQuadrilateral3D4N2310 = 1328 , IntersectionQuadrilateral3D4N3210 = 1238 , IntersectionQuadrilateral3D4N3010 = 1038 ,
  IntersectionQuadrilateral3D4N0310 = 1308 , IntersectionQuadrilateral3D4N0112 = 21108 , IntersectionQuadrilateral3D4N1012 = 21018 , IntersectionQuadrilateral3D4N1212 = 21218 ,
  IntersectionQuadrilateral3D4N2112 = 21128 , IntersectionQuadrilateral3D4N2312 = 21328 , IntersectionQuadrilateral3D4N3212 = 21238 , IntersectionQuadrilateral3D4N3012 = 21038 ,
  IntersectionQuadrilateral3D4N0312 = 21308 , IntersectionQuadrilateral3D4N0121 = 12108 , IntersectionQuadrilateral3D4N1021 = 12018 , IntersectionQuadrilateral3D4N1221 = 12218 ,
  IntersectionQuadrilateral3D4N2121 = 12128 , IntersectionQuadrilateral3D4N2321 = 12328 , IntersectionQuadrilateral3D4N3221 = 12238 , IntersectionQuadrilateral3D4N3021 = 12038 ,
  IntersectionQuadrilateral3D4N0321 = 12308 , IntersectionQuadrilateral3D4N0123 = 32108 , IntersectionQuadrilateral3D4N1023 = 32018 , IntersectionQuadrilateral3D4N1223 = 32218 ,
  IntersectionQuadrilateral3D4N2123 = 32128 , IntersectionQuadrilateral3D4N2323 = 32328 , IntersectionQuadrilateral3D4N3223 = 32238 , IntersectionQuadrilateral3D4N3023 = 32038 ,
  IntersectionQuadrilateral3D4N0323 = 32308 , IntersectionQuadrilateral3D4N0132 = 23108 , IntersectionQuadrilateral3D4N1032 = 23018 , IntersectionQuadrilateral3D4N1232 = 23218 ,
  IntersectionQuadrilateral3D4N2132 = 23128 , IntersectionQuadrilateral3D4N2332 = 23328 , IntersectionQuadrilateral3D4N3232 = 23238 , IntersectionQuadrilateral3D4N3032 = 23038 ,
  IntersectionQuadrilateral3D4N0332 = 23308 , IntersectionQuadrilateral3D4N0130 = 3108 , IntersectionQuadrilateral3D4N1030 = 3018 , IntersectionQuadrilateral3D4N1230 = 3218 ,
  IntersectionQuadrilateral3D4N2130 = 3128 , IntersectionQuadrilateral3D4N2330 = 3328 , IntersectionQuadrilateral3D4N3230 = 3238 , IntersectionQuadrilateral3D4N3030 = 3038 ,
  IntersectionQuadrilateral3D4N0330 = 3308 , IntersectionQuadrilateral3D4N0103 = 30108 , IntersectionQuadrilateral3D4N1003 = 30018 , IntersectionQuadrilateral3D4N1203 = 30218 ,
  IntersectionQuadrilateral3D4N2103 = 30128 , IntersectionQuadrilateral3D4N2303 = 30328 , IntersectionQuadrilateral3D4N3203 = 30238 , IntersectionQuadrilateral3D4N3003 = 30038 ,
  IntersectionQuadrilateral3D4N0303 = 30308
}
 Case for 3D quadrilateral intersected with another 3D quadrilateral. More...
 
enum class  PointBelongsQuadrilateral3D4NTriangle3D3N {
  SlaveQuadrilateral3D4N0 = 0 , SlaveQuadrilateral3D4N1 = 1 , SlaveQuadrilateral3D4N2 = 2 , SlaveQuadrilateral3D4N3 = 3 ,
  MasterTriangle3D3N0 = 4 , MasterTriangle3D3N1 = 5 , MasterTriangle3D3N2 = 6 , IntersectionQuadrilateral3D4NTriangle3D3N = 7 ,
  IntersectionQuadrilateral3D4NTriangle3D3N0101 = 10107 , IntersectionQuadrilateral3D4NTriangle3D3N1001 = 1107 , IntersectionQuadrilateral3D4NTriangle3D3N1201 = 21107 , IntersectionQuadrilateral3D4NTriangle3D3N2101 = 12107 ,
  IntersectionQuadrilateral3D4NTriangle3D3N2301 = 32107 , IntersectionQuadrilateral3D4NTriangle3D3N3201 = 23107 , IntersectionQuadrilateral3D4NTriangle3D3N3001 = 3107 , IntersectionQuadrilateral3D4NTriangle3D3N0301 = 30107 ,
  IntersectionQuadrilateral3D4NTriangle3D3N0110 = 10017 , IntersectionQuadrilateral3D4NTriangle3D3N1010 = 1017 , IntersectionQuadrilateral3D4NTriangle3D3N1210 = 21017 , IntersectionQuadrilateral3D4NTriangle3D3N2110 = 12017 ,
  IntersectionQuadrilateral3D4NTriangle3D3N2310 = 32017 , IntersectionQuadrilateral3D4NTriangle3D3N3210 = 23017 , IntersectionQuadrilateral3D4NTriangle3D3N3010 = 3017 , IntersectionQuadrilateral3D4NTriangle3D3N0310 = 30017 ,
  IntersectionQuadrilateral3D4NTriangle3D3N0112 = 10217 , IntersectionQuadrilateral3D4NTriangle3D3N1012 = 1217 , IntersectionQuadrilateral3D4NTriangle3D3N1212 = 21217 , IntersectionQuadrilateral3D4NTriangle3D3N2112 = 12217 ,
  IntersectionQuadrilateral3D4NTriangle3D3N2312 = 32217 , IntersectionQuadrilateral3D4NTriangle3D3N3212 = 23217 , IntersectionQuadrilateral3D4NTriangle3D3N3012 = 3217 , IntersectionQuadrilateral3D4NTriangle3D3N0312 = 30217 ,
  IntersectionQuadrilateral3D4NTriangle3D3N0121 = 10127 , IntersectionQuadrilateral3D4NTriangle3D3N1021 = 1127 , IntersectionQuadrilateral3D4NTriangle3D3N1221 = 21127 , IntersectionQuadrilateral3D4NTriangle3D3N2121 = 12127 ,
  IntersectionQuadrilateral3D4NTriangle3D3N2321 = 32127 , IntersectionQuadrilateral3D4NTriangle3D3N3221 = 23127 , IntersectionQuadrilateral3D4NTriangle3D3N3021 = 3127 , IntersectionQuadrilateral3D4NTriangle3D3N0321 = 30127 ,
  IntersectionQuadrilateral3D4NTriangle3D3N0120 = 10027 , IntersectionQuadrilateral3D4NTriangle3D3N1020 = 1027 , IntersectionQuadrilateral3D4NTriangle3D3N1220 = 21027 , IntersectionQuadrilateral3D4NTriangle3D3N2120 = 12027 ,
  IntersectionQuadrilateral3D4NTriangle3D3N2320 = 32027 , IntersectionQuadrilateral3D4NTriangle3D3N3220 = 23027 , IntersectionQuadrilateral3D4NTriangle3D3N3020 = 3027 , IntersectionQuadrilateral3D4NTriangle3D3N0320 = 30027 ,
  IntersectionQuadrilateral3D4NTriangle3D3N0102 = 10207 , IntersectionQuadrilateral3D4NTriangle3D3N1002 = 1207 , IntersectionQuadrilateral3D4NTriangle3D3N1202 = 21207 , IntersectionQuadrilateral3D4NTriangle3D3N2102 = 12207 ,
  IntersectionQuadrilateral3D4NTriangle3D3N2302 = 32207 , IntersectionQuadrilateral3D4NTriangle3D3N3202 = 23207 , IntersectionQuadrilateral3D4NTriangle3D3N3002 = 3207 , IntersectionQuadrilateral3D4NTriangle3D3N0302 = 30207
}
 Case for 3D triangle intersected with quadrilateral 3D. More...
 
enum class  PointBelongsTriangle3D3NQuadrilateral3D4N {
  SlaveTriangle3D3N0 = 0 , SlaveTriangle3D3N1 = 1 , SlaveTriangle3D3N2 = 2 , MasterQuadrilateral3D4N0 = 3 ,
  MasterQuadrilateral3D4N1 = 4 , MasterQuadrilateral3D4N2 = 5 , MasterQuadrilateral3D4N3 = 6 , IntersectionTriangle3D3NQuadrilateral3D4N = 7 ,
  IntersectionTriangle3D3NQuadrilateral3D4N0101 = 10107 , IntersectionTriangle3D3NQuadrilateral3D4N0110 = 1107 , IntersectionTriangle3D3NQuadrilateral3D4N0112 = 21107 , IntersectionTriangle3D3NQuadrilateral3D4N0121 = 12107 ,
  IntersectionTriangle3D3NQuadrilateral3D4N0123 = 32107 , IntersectionTriangle3D3NQuadrilateral3D4N0132 = 23107 , IntersectionTriangle3D3NQuadrilateral3D4N0130 = 3107 , IntersectionTriangle3D3NQuadrilateral3D4N0103 = 30107 ,
  IntersectionTriangle3D3NQuadrilateral3D4N1001 = 10017 , IntersectionTriangle3D3NQuadrilateral3D4N1010 = 1017 , IntersectionTriangle3D3NQuadrilateral3D4N1012 = 21017 , IntersectionTriangle3D3NQuadrilateral3D4N1021 = 12017 ,
  IntersectionTriangle3D3NQuadrilateral3D4N1023 = 32017 , IntersectionTriangle3D3NQuadrilateral3D4N1032 = 23017 , IntersectionTriangle3D3NQuadrilateral3D4N1030 = 3017 , IntersectionTriangle3D3NQuadrilateral3D4N1003 = 30017 ,
  IntersectionTriangle3D3NQuadrilateral3D4N1201 = 10217 , IntersectionTriangle3D3NQuadrilateral3D4N1210 = 1217 , IntersectionTriangle3D3NQuadrilateral3D4N1212 = 21217 , IntersectionTriangle3D3NQuadrilateral3D4N1221 = 12217 ,
  IntersectionTriangle3D3NQuadrilateral3D4N1223 = 32217 , IntersectionTriangle3D3NQuadrilateral3D4N1232 = 23217 , IntersectionTriangle3D3NQuadrilateral3D4N1230 = 3217 , IntersectionTriangle3D3NQuadrilateral3D4N1203 = 30217 ,
  IntersectionTriangle3D3NQuadrilateral3D4N2101 = 10127 , IntersectionTriangle3D3NQuadrilateral3D4N2110 = 1127 , IntersectionTriangle3D3NQuadrilateral3D4N2112 = 21127 , IntersectionTriangle3D3NQuadrilateral3D4N2121 = 12127 ,
  IntersectionTriangle3D3NQuadrilateral3D4N2123 = 32127 , IntersectionTriangle3D3NQuadrilateral3D4N2132 = 23127 , IntersectionTriangle3D3NQuadrilateral3D4N2130 = 3127 , IntersectionTriangle3D3NQuadrilateral3D4N2103 = 30127 ,
  IntersectionTriangle3D3NQuadrilateral3D4N2001 = 10027 , IntersectionTriangle3D3NQuadrilateral3D4N2010 = 1027 , IntersectionTriangle3D3NQuadrilateral3D4N2012 = 21027 , IntersectionTriangle3D3NQuadrilateral3D4N2021 = 12027 ,
  IntersectionTriangle3D3NQuadrilateral3D4N2023 = 32027 , IntersectionTriangle3D3NQuadrilateral3D4N2032 = 23027 , IntersectionTriangle3D3NQuadrilateral3D4N2030 = 3027 , IntersectionTriangle3D3NQuadrilateral3D4N2003 = 30027 ,
  IntersectionTriangle3D3NQuadrilateral3D4N0201 = 10207 , IntersectionTriangle3D3NQuadrilateral3D4N0210 = 1207 , IntersectionTriangle3D3NQuadrilateral3D4N0212 = 21207 , IntersectionTriangle3D3NQuadrilateral3D4N0221 = 12207 ,
  IntersectionTriangle3D3NQuadrilateral3D4N0223 = 32207 , IntersectionTriangle3D3NQuadrilateral3D4N0232 = 23207 , IntersectionTriangle3D3NQuadrilateral3D4N0230 = 3207 , IntersectionTriangle3D3NQuadrilateral3D4N0203 = 30207
}
 Case for 3D quadrilateral intersected with triangle 3D. More...
 
enum  AMGCLSmoother {
  SPAI0 , SPAI1 , ILU0 , DAMPED_JACOBI ,
  GAUSS_SEIDEL , CHEBYSHEV
}
 
enum  AMGCLIterativeSolverType {
  LGMRES , FGMRES , GMRES , BICGSTAB ,
  CG , BICGSTAB_WITH_GMRES_FALLBACK , BICGSTAB2
}
 
enum  AMGCLCoarseningType { RUGE_STUBEN , AGGREGATION , SA , SA_EMIN }
 
enum class  SCALING_DIAGONAL { NO_SCALING = 0 , CONSIDER_NORM_DIAGONAL = 1 , CONSIDER_MAX_DIAGONAL = 2 , CONSIDER_PRESCRIBED_DIAGONAL = 3 }
 
enum class  SpatialContainer { KDTree , Octree , BinsStatic , BinsDynamic }
 This enum defines the different spatial containers available. More...
 
enum class  FrictionalCase {
  FRICTIONLESS = 0 , FRICTIONLESS_COMPONENTS = 1 , FRICTIONAL = 2 , FRICTIONLESS_PENALTY = 3 ,
  FRICTIONAL_PENALTY = 4
}
 An enumeration of the different cases of friction that can be used in the contact search process. More...
 
enum class  NormalDerivativesComputation { NO_DERIVATIVES_COMPUTATION = 0 , ELEMENTAL_DERIVATIVES = 1 , NODAL_ELEMENTAL_DERIVATIVES = 2 , NO_DERIVATIVES_COMPUTATION_WITH_NORMAL_UPDATE = 3 }
 An enumeration of the different options for normal derivatives computation. More...
 
enum class  MMGLibrary { MMG2D = 0 , MMG3D = 1 , MMGS = 2 }
 This enum defines the type of MMG libray used. More...
 
enum class  PMMGLibrary { PMMG3D = 1 }
 This enum defines the type of PMMG libray used. More...
 
enum class  FrameworkEulerLagrange { EULERIAN = 0 , LAGRANGIAN = 1 , ALE = 2 }
 This enums allows to differentiate the working framework. More...
 
enum class  DiscretizationOption { STANDARD = 0 , LAGRANGIAN = 1 , ISOSURFACE = 2 }
 This enums allows to differentiate the discretization options. More...
 
enum class  ShellKinematics { LINEAR , NONLINEAR_COROTATIONAL }
 
enum  Configuration { Initial = 0 , Current = 1 }
 
enum  AztecScalingType { NoScaling , LeftScaling , SymmetricScaling }
 

Functions

 KRATOS_CREATE_LOCAL_FLAG (DataValueContainer, OVERWRITE_OLD_VALUES, 0)
 
bool operator== (const Flags &Left, const Flags &Right)
 
bool operator!= (const Flags &Left, const Flags &Right)
 
Flags operator| (const Flags &Left, const Flags &Right)
 
Flags operator& (const Flags &Left, const Flags &Right)
 
std::ostream & operator<< (std::ostream &rOStream, const Expression &rThis)
 
void AddKratosComponent (std::string const &Name, ExplicitBuilderType const &ThisComponent)
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Hexahedra3D20< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Hexahedra3D20< TPointType > &rThis)
 
template<class TPointType >
const GeometryData Hexahedra3D20< TPointType >::msGeometryData & msGeometryDimension (), Hexahedra3D20< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Hexahedra3D27< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Hexahedra3D27< TPointType > &rThis)
 
template<class TPointType >
const GeometryData Hexahedra3D27< TPointType >::msGeometryData & msGeometryDimension (), Hexahedra3D27< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Hexahedra3D8< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Hexahedra3D8< TPointType > &rThis)
 
template<class TPointType >
const GeometryData Hexahedra3D8< TPointType >::msGeometryData & msGeometryDimension (), Hexahedra3D8< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, HexahedraInterface3D8< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const HexahedraInterface3D8< TPointType > &rThis)
 
template<class TPointType >
const GeometryData HexahedraInterface3D8< TPointType >::msGeometryData & msGeometryDimension (), HexahedraInterface3D8< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Line2D2< TPointType >::msGeometryData & msGeometryDimension (), Line2D2< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Line2D3< TPointType >::msGeometryData & msGeometryDimension (), Line2D3< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Line2D4< TPointType >::msGeometryData & msGeometryDimension (), Line2D4< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Line2D5< TPointType >::msGeometryData & msGeometryDimension (), Line2D5< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Line3D2< TPointType >::msGeometryData & msGeometryDimension (), Line3D2< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Line3D3< TPointType >::msGeometryData & msGeometryDimension (), Line3D3< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData LineGaussLobatto3D2< TPointType >::msGeometryData & msGeometryDimension (), LineGaussLobatto3D2< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Point2D< TPointType >::msGeometryData & msGeometryDimension (), Point2D< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Point3D< TPointType >::msGeometryData & msGeometryDimension (), Point3D< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Prism3D15< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Prism3D15< TPointType > &rThis)
 output stream function More...
 
template<class TPointType >
const GeometryData Prism3D15< TPointType >::msGeometryData & msGeometryDimension (), Prism3D15< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Prism3D6< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Prism3D6< TPointType > &rThis)
 output stream function More...
 
template<class TPointType >
const GeometryData Prism3D6< TPointType >::msGeometryData & msGeometryDimension (), Prism3D6< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData PrismInterface3D6< TPointType >::msGeometryData & msGeometryDimension (), PrismInterface3D6< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Pyramid3D13< TPointType >::msGeometryData & msGeometryDimension (), Pyramid3D13< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Pyramid3D5< TPointType >::msGeometryData & msGeometryDimension (), Pyramid3D5< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Quadrilateral2D4< TPointType >::msGeometryData & msGeometryDimension (), Quadrilateral2D4< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Quadrilateral2D8< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Quadrilateral2D8< TPointType > &rThis)
 
template<class TPointType >
const GeometryData Quadrilateral2D8< TPointType >::msGeometryData & msGeometryDimension (), Quadrilateral2D8< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Quadrilateral2D9< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Quadrilateral2D9< TPointType > &rThis)
 output stream function More...
 
template<class TPointType >
const GeometryData Quadrilateral2D9< TPointType >::msGeometryData & msGeometryDimension (), Quadrilateral2D9< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Quadrilateral3D4< TPointType >::msGeometryData & msGeometryDimension (), Quadrilateral3D4< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Quadrilateral3D8< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Quadrilateral3D8< TPointType > &rThis)
 
template<class TPointType >
const GeometryData Quadrilateral3D8< TPointType >::msGeometryData & msGeometryDimension (), Quadrilateral3D8< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Quadrilateral3D9< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Quadrilateral3D9< TPointType > &rThis)
 
template<class TPointType >
const GeometryData Quadrilateral3D9< TPointType >::msGeometryData & msGeometryDimension (), Quadrilateral3D9< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData QuadrilateralInterface2D4< TPointType >::msGeometryData & msGeometryDimension (), QuadrilateralInterface2D4< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData QuadrilateralInterface3D4< TPointType >::msGeometryData & msGeometryDimension (), QuadrilateralInterface3D4< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
void AddKratosComponent (std::string const &Name, Geometry< Node > const &ThisComponent)
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Tetrahedra3D4< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Tetrahedra3D4< TPointType > &rThis)
 
template<class TPointType >
const GeometryData Tetrahedra3D4< TPointType >::msGeometryData & msGeometryDimension (), Tetrahedra3D4< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Triangle2D10< TPointType >::msGeometryData & msGeometryDimension (), Triangle2D10< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Triangle2D15< TPointType >::msGeometryData & msGeometryDimension (), Triangle2D15< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Triangle2D3< TPointType >::msGeometryData & msGeometryDimension (), Triangle2D3< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Triangle2D6< TPointType >::msGeometryData & msGeometryDimension (), Triangle2D6< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Triangle3D3< TPointType >::msGeometryData & msGeometryDimension (), Triangle3D3< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
const GeometryData Triangle3D6< TPointType >::msGeometryData & msGeometryDimension (), Triangle3D6< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
void AddKratosComponent (std::string const &Name, Condition const &ThisComponent)
 
void AddKratosComponent (std::string const &Name, ConstitutiveLaw const &ThisComponent)
 
void AddKratosComponent (std::string const &Name, Variable< ConstitutiveLaw::Pointer > const &ThisComponent)
 
void AddKratosComponent (std::string const &Name, Element const &ThisComponent)
 
void AddKratosComponent (const std::string &rName, const Variable< bool > &rComponent)
 
void AddKratosComponent (const std::string &rName, const Variable< int > &rComponent)
 
void AddKratosComponent (const std::string &rName, const Variable< unsigned int > &rComponent)
 
void AddKratosComponent (const std::string &rName, const Variable< double > &rComponent)
 
void AddKratosComponent (const std::string &rName, const Variable< array_1d< double, 3 >> &rComponent)
 
void AddKratosComponent (const std::string &rName, const Variable< array_1d< double, 4 >> &rComponent)
 
void AddKratosComponent (const std::string &rName, const Variable< array_1d< double, 6 >> &rComponent)
 
void AddKratosComponent (const std::string &rName, const Variable< array_1d< double, 9 >> &rComponent)
 
void AddKratosComponent (const std::string &rName, const Variable< Quaternion< double >> &rComponent)
 
void AddKratosComponent (const std::string &rName, const Variable< Vector > &rComponent)
 
void AddKratosComponent (const std::string &rName, const Variable< std::string > &rComponent)
 
void AddKratosComponent (const std::string &rName, const Flags &rComponent)
 
void AddKratosComponent (const std::string &rName, const Variable< Flags > &rComponent)
 
template<class TComponentType >
void AddKratosComponent (const std::string &rName, const TComponentType &rComponent)
 
namespace KRATOS_DEPRECATED_MESSAGE ("Please use std::filesystem directly") filesystem
 
constexpr int GetMajorVersion ()
 
constexpr int GetMinorVersion ()
 
KRATOS_API_EXPORT std::string GetPatchVersion ()
 
KRATOS_API_EXPORT std::string GetCommit ()
 
KRATOS_API_EXPORT std::string GetBranchName ()
 
KRATOS_API_EXPORT std::string GetBuildType ()
 
KRATOS_API_EXPORT std::string GetVersionString ()
 
KRATOS_API_EXPORT std::string GetOSName ()
 
KRATOS_API_EXPORT std::string GetCompiler ()
 
 KRATOS_DEFINE_VARIABLE (Vector, BIOT_STRAIN_VECTOR)
 
 KRATOS_DEFINE_VARIABLE (Matrix, BIOT_STRAIN_TENSOR)
 
template<typename T >
constexpr bool IsCorrectType (MM_typecode &mm_code)
 
template<>
constexpr bool IsCorrectType< double > (MM_typecode &mm_code)
 
template<>
constexpr bool IsCorrectType< std::complex< double > > (MM_typecode &mm_code)
 
bool ReadMatrixMarketMatrixEntry (FILE *f, int &I, int &J, double &V)
 
bool ReadMatrixMarketMatrixEntry (FILE *f, int &I, int &J, std::complex< double > &V)
 
template<typename CompressedMatrixType >
bool ReadMatrixMarketMatrix (const char *FileName, CompressedMatrixType &M)
 
void SetMatrixMarketValueTypeCode (MM_typecode &mm_code, const double &value)
 
void SetMatrixMarketValueTypeCode (MM_typecode &mm_code, const std::complex< double > &value)
 
int WriteMatrixMarketMatrixEntry (FILE *f, int I, int J, const double &entry)
 
int WriteMatrixMarketMatrixEntry (FILE *f, int I, int J, const std::complex< double > &entry)
 
template<typename CompressedMatrixType >
bool WriteMatrixMarketMatrix (const char *FileName, CompressedMatrixType &M, bool Symmetric)
 
bool ReadMatrixMarketVectorEntry (FILE *f, double &entry)
 
bool ReadMatrixMarketVectorEntry (FILE *f, std::complex< double > &entry)
 
template<typename VectorType >
bool ReadMatrixMarketVector (const char *FileName, VectorType &V)
 
int WriteMatrixMarketVectorEntry (FILE *f, const double &entry)
 
int WriteMatrixMarketVectorEntry (FILE *f, const std::complex< double > &entry)
 
template<typename VectorType >
bool WriteMatrixMarketVector (const char *FileName, VectorType &V)
 
 KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS (MESH_DISPLACEMENT)
 
 KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS (MESH_ACCELERATION)
 
 KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS (MESH_REACTION)
 
 KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS (MESH_RHS)
 
 KRATOS_DEFINE_VARIABLE (int, LAPLACIAN_DIRECTION)
 
 KRATOS_DEFINE_VARIABLE (double, MESH_POISSON_RATIO)
 
template<typename C , typename... Args>
intrusive_ptr< C > make_intrusive (Args &&...args)
 
template<typename C , typename... Args>
shared_ptr< C > make_shared (Args &&...args)
 
template<typename C , typename... Args>
unique_ptr< C > make_unique (Args &&...args)
 
template<class T >
std::ostream & operator<< (std::ostream &rOStream, const Kratos::weak_ptr< T > &rData)
 
template<class T >
std::ostream & operator<< (std::ostream &rOStream, const Kratos::intrusive_ptr< T > &rData)
 
 KRATOS_CREATE_LOCAL_FLAG (LoggerOutput, WARNING_PREFIX, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (LoggerOutput, INFO_PREFIX, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (LoggerOutput, DETAIL_PREFIX, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (LoggerOutput, DEBUG_PREFIX, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (LoggerOutput, TRACE_PREFIX, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (VtuOutput, NODES, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (VtuOutput, CONDITIONS, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (VtuOutput, ELEMENTS, 3)
 
template void VtuOutput::AddContainerExpression< ModelPart::NodesContainerType > (const std::string &, const typename ContainerExpression< ModelPart::NodesContainerType >::Pointer)
 
template void VtuOutput::AddContainerExpression< ModelPart::ConditionsContainerType > (const std::string &, const typename ContainerExpression< ModelPart::ConditionsContainerType >::Pointer)
 
template void VtuOutput::AddContainerExpression< ModelPart::ElementsContainerType > (const std::string &, const typename ContainerExpression< ModelPart::ElementsContainerType >::Pointer)
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream & operator>> (std::istream &rIStream, AMGCL_NS_Solver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream & operator<< (std::ostream &rOStream, const AMGCL_NS_Solver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 
void AMGCLScalarSolve (TUblasSparseSpace< double >::MatrixType &rA, TUblasSparseSpace< double >::VectorType &rX, TUblasSparseSpace< double >::VectorType &rB, TUblasSparseSpace< double >::IndexType &rIterationNumber, double &rResidual, const boost::property_tree::ptree &amgclParams, int verbosity_level, bool use_gpgpu)
 
template<int TBlockSize>
void AMGCLBlockSolve (TUblasSparseSpace< double >::MatrixType &rA, TUblasSparseSpace< double >::VectorType &rX, TUblasSparseSpace< double >::VectorType &rB, TUblasSparseSpace< double >::IndexType &rIterationNumber, double &rResidual, boost::property_tree::ptree amgclParams, int verbosity_level, bool use_gpgpu)
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream & operator>> (std::istream &rIStream, DirectSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream & operator<< (std::ostream &rOStream, const DirectSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream & operator>> (std::istream &rIStream, SkylineLUFactorizationSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream & operator<< (std::ostream &rOStream, const SkylineLUFactorizationSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::istream & operator>> (std::istream &IStream, TFQMRSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::ostream & operator<< (std::ostream &OStream, const TFQMRSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 output stream function More...
 
 KRATOS_CREATE_LOCAL_FLAG (MapperFlags, SWAP_SIGN, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (MapperFlags, ADD_VALUES, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (MapperFlags, REMESHED, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (MapperFlags, USE_TRANSPOSE, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (MapperFlags, ORIGIN_ONLY, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (MapperFlags, DESTINATION_ONLY, 5)
 
 KRATOS_CREATE_LOCAL_FLAG (MapperFlags, TO_NON_HISTORICAL, 6)
 
 KRATOS_CREATE_LOCAL_FLAG (MapperFlags, FROM_NON_HISTORICAL, 7)
 
 KRATOS_CREATE_LOCAL_FLAG (MapperFlags, INTERNAL_USE_TRANSPOSE, 8)
 
void AddKratosComponent (std::string const &Name, Modeler const &ThisComponent)
 
 KRATOS_CREATE_LOCAL_FLAG (CalculateDiscontinuousDistanceToSkinProcessFlags, CALCULATE_ELEMENTAL_EDGE_DISTANCES, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (CalculateDiscontinuousDistanceToSkinProcessFlags, CALCULATE_ELEMENTAL_EDGE_DISTANCES_EXTRAPOLATED, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (CalculateDiscontinuousDistanceToSkinProcessFlags, USE_POSITIVE_EPSILON_FOR_ZERO_VALUES, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (EntitiesEraseProcessFlags, REMOVE_FROM_ALL_LEVELS, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (EntitiesEraseProcessFlags, ERASE_ALL_ENTITIES, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (FindIntersectedGeometricalObjectsProcess, INTERSECTING_CONDITIONS, 0)
 Local Flags. More...
 
 KRATOS_CREATE_LOCAL_FLAG (FindIntersectedGeometricalObjectsProcess, INTERSECTING_ELEMENTS, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (FindIntersectedGeometricalObjectsProcess, INTERSECTED_CONDITIONS, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (FindIntersectedGeometricalObjectsProcess, INTERSECTED_ELEMENTS, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (FindIntersectedGeometricalObjectsWithOBBProcess, DEBUG_OBB, 4)
 Local Flags. More...
 
 KRATOS_CREATE_LOCAL_FLAG (FindIntersectedGeometricalObjectsWithOBBProcess, SEPARATING_AXIS_THEOREM, 5)
 
 KRATOS_CREATE_LOCAL_FLAG (FindIntersectedGeometricalObjectsWithOBBProcess, BUILD_OBB_FROM_BB, 6)
 
 KRATOS_CREATE_LOCAL_FLAG (FromJSONCheckResultProcess, CORRECT_RESULT, 0)
 Local Flags. More...
 
 KRATOS_CREATE_LOCAL_FLAG (FromJSONCheckResultProcess, HISTORICAL_VALUE, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (FromJSONCheckResultProcess, CHECK_ONLY_LOCAL_ENTITIES, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (FromJSONCheckResultProcess, NODES_CONTAINER_INITIALIZED, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (FromJSONCheckResultProcess, ELEMENTS_CONTAINER_INITIALIZED, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (FromJSONCheckResultProcess, NODES_DATABASE_INITIALIZED, 5)
 
 KRATOS_CREATE_LOCAL_FLAG (FromJSONCheckResultProcess, ELEMENTS_DATABASE_INITIALIZED, 6)
 
 KRATOS_CREATE_LOCAL_FLAG (MeshCoarseningProcess, COARSE_MESH_NODE, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (MeshNodeCollapsingProcess, TO_COLLAPSE, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (TetrahedralMeshOrientationCheck, ASSIGN_NEIGHBOUR_ELEMENTS_TO_CONDITIONS, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (TetrahedralMeshOrientationCheck, COMPUTE_NODAL_NORMALS, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (TetrahedralMeshOrientationCheck, COMPUTE_CONDITION_NORMALS, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (TetrahedralMeshOrientationCheck, MAKE_VOLUMES_POSITIVE, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (TetrahedralMeshOrientationCheck, ALLOW_REPEATED_CONDITIONS, 4)
 
template void TimeAveragingProcess::CalculateTimeIntegratedNonHistoricalQuantity< double, ModelPart::NodesContainerType > (ModelPart::NodesContainerType &, const Variable< double > &, const Variable< double > &, const double) const
 
template void TimeAveragingProcess::CalculateTimeIntegratedNonHistoricalQuantity< double, ModelPart::ElementsContainerType > (ModelPart::ElementsContainerType &, const Variable< double > &, const Variable< double > &, const double) const
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, USE_ELEMENT_PROVIDED_STRAIN, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, COMPUTE_STRESS, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, COMPUTE_CONSTITUTIVE_TENSOR, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, COMPUTE_STRAIN_ENERGY, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, ISOCHORIC_TENSOR_ONLY, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, VOLUMETRIC_TENSOR_ONLY, 5)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, MECHANICAL_RESPONSE_ONLY, 6)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, THERMAL_RESPONSE_ONLY, 7)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, INCREMENTAL_STRAIN_MEASURE, 8)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, INITIALIZE_MATERIAL_RESPONSE, 9)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, FINALIZE_MATERIAL_RESPONSE, 10)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, FINITE_STRAINS, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, INFINITESIMAL_STRAINS, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, THREE_DIMENSIONAL_LAW, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, PLANE_STRAIN_LAW, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, PLANE_STRESS_LAW, 5)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, AXISYMMETRIC_LAW, 6)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, U_P_LAW, 7)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, ISOTROPIC, 8)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveLaw, ANISOTROPIC, 9)
 
 KRATOS_CREATE_VARIABLE (double, Ypr) void KratosApplication
 
 KRATOS_CREATE_VARIABLE (int, CONVERGENCE_ACCELERATOR_ITERATION)
 
 KRATOS_CREATE_VARIABLE (double, MAPPER_SCALAR_PROJECTION_RHS)
 
 KRATOS_CREATE_VARIABLE (double, SCALAR_PROJECTED)
 
 KRATOS_CREATE_VARIABLE (double, FICTITIOUS_FLUID_DENSITY)
 
 KRATOS_CREATE_VARIABLE (double, SCALAR_INTERFACE_RESIDUAL)
 
 KRATOS_CREATE_VARIABLE (double, RELAXED_SCALAR)
 
 KRATOS_CREATE_VARIABLE (double, OLD_RELAXED_SCALAR)
 
 KRATOS_CREATE_VARIABLE (double, RELAXED_SCALAR_TRACTION)
 
 KRATOS_CREATE_VARIABLE (double, OLD_RELAXED_SCALAR_TRACTION)
 
 KRATOS_CREATE_VARIABLE (double, SCALAR_TRACTION_INTERFACE_RESIDUAL)
 
 KRATOS_CREATE_VARIABLE (double, FSI_INTERFACE_RESIDUAL_NORM)
 
 KRATOS_CREATE_VARIABLE (double, FSI_INTERFACE_MESH_RESIDUAL_NORM)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (MAPPER_VECTOR_PROJECTION_RHS)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (VAUX_EQ_TRACTION)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (VECTOR_PROJECTED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (RELAXED_DISPLACEMENT)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (OLD_RELAXED_DISPLACEMENT)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (RELAXED_TRACTION)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (OLD_RELAXED_TRACTION)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (FSI_INTERFACE_RESIDUAL)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (TRACTION_INTERFACE_RESIDUAL)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (FSI_INTERFACE_MESH_RESIDUAL)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (POSITIVE_MAPPED_VECTOR_VARIABLE)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (NEGATIVE_MAPPED_VECTOR_VARIABLE)
 
 KRATOS_CREATE_LOCAL_FLAG (IO, READ, 1)
 Local Flags. More...
 
 KRATOS_CREATE_LOCAL_FLAG (IO, WRITE, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (IO, APPEND, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (IO, IGNORE_VARIABLES_ERROR, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (IO, SKIP_TIMER, 5)
 
 KRATOS_CREATE_LOCAL_FLAG (IO, MESH_ONLY, 6)
 
 KRATOS_CREATE_LOCAL_FLAG (IO, SCIENTIFIC_PRECISION, 7)
 
 KRATOS_CREATE_VARIABLE (IndexSet::Pointer, INDEX_SET) KRATOS_CREATE_VARIABLE(IndexMap
 
 KRATOS_CREATE_VARIABLE (Vector, BIOT_STRAIN_VECTOR)
 
 KRATOS_CREATE_VARIABLE (Matrix, BIOT_STRAIN_TENSOR)
 
 KRATOS_CREATE_LOCAL_FLAG (ModelPart, ALL_ENTITIES, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (ModelPart, OVERWRITE_ENTITIES, 1)
 
template void ParallelEnvironment::RegisterFillCommunicatorFactory< const std::string > (std::function< FillCommunicator::Pointer(ModelPart &, const std::string &)> CommunicatorFactory)
 
template void ParallelEnvironment::RegisterCommunicatorFactory< const std::string > (std::function< Communicator::UniquePointer(ModelPart &, const std::string &)> CommunicatorFactory)
 
 KRATOS_CREATE_LOCAL_FLAG (Serializer, MPI, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (Serializer, SHALLOW_GLOBAL_POINTERS_SERIALIZATION, 1)
 
template<std::size_t TDimension, class TPointType , class TContainerType , class TPointerType , class TIteratorType , class TDistanceIteratorType , class TDistanceFunction >
std::ostream & operator<< (std::ostream &rOStream, Bins< TDimension, TPointType, TContainerType, TPointerType, TIteratorType, TDistanceIteratorType, TDistanceFunction > &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const kDOP &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const @{KRATOS_NAME_CAMEL}&rThis)
 output stream function More...
 
template<class TDataType >
void AtomicAdd (TDataType &target, const TDataType &value)
 
template<class TDataType , std::size_t ArraySize>
void AtomicAdd (array_1d< TDataType, ArraySize > &target, const array_1d< TDataType, ArraySize > &value)
 
template<class TVectorType1 , class TVectorType2 >
void AtomicAddVector (TVectorType1 &target, const TVectorType2 &value)
 
template<class TMatrixType1 , class TMatrixType2 >
void AtomicAddMatrix (TMatrixType1 &target, const TMatrixType2 &value)
 
template<class TDataType >
void AtomicSub (TDataType &target, const TDataType &value)
 
template<class TDataType , std::size_t ArraySize>
void AtomicSub (array_1d< TDataType, ArraySize > &target, const array_1d< TDataType, ArraySize > &value)
 
template<class TVectorType1 , class TVectorType2 >
void AtomicSubVector (TVectorType1 &target, const TVectorType2 &value)
 
template<class TMatrixType1 , class TMatrixType2 >
void AtomicSubMatrix (TMatrixType1 &target, const TMatrixType2 &value)
 
template<class TDataType >
void AtomicMult (TDataType &target, const TDataType &value)
 
template<class TDataType , std::size_t ArraySize>
void AtomicMult (array_1d< TDataType, ArraySize > &target, const array_1d< TDataType, ArraySize > &value)
 
template<class TVectorType1 , class TVectorType2 >
void AtomicMultVector (TVectorType1 &target, const TVectorType2 &value)
 
template<class TMatrixType1 , class TMatrixType2 >
void AtomicMultMatrix (TMatrixType1 &target, const TMatrixType2 &value)
 
template<class TDataType >
void AtomicDiv (TDataType &target, const TDataType &value)
 
template<class TDataType , std::size_t ArraySize>
void AtomicDiv (array_1d< TDataType, ArraySize > &target, const array_1d< TDataType, ArraySize > &value)
 
template<class TVectorType1 , class TVectorType2 >
void AtomicDivVector (TVectorType1 &target, const TVectorType2 &value)
 
template<class TMatrixType1 , class TMatrixType2 >
void AtomicDivMatrix (TMatrixType1 &target, const TMatrixType2 &value)
 
std::ostream & operator<< (std::ostream &rOStream, const BuiltinTimer &rThis)
 output stream function More...
 
bool CheckThereIsNotx (const std::string &rString)
 
template<class TVariableType >
IndirectScalar< typename TVariableType::Type > MakeIndirectScalar (Node &rNode, const TVariableType &rVariable)
 
template<class TVariableType >
IndirectScalar< typename TVariableType::Type > MakeIndirectScalar (Node &rNode, const TVariableType &rVariable, std::size_t Step)
 
std::ostream & operator<< (std::ostream &rOStream, const IntervalUtility &rThis)
 output stream function More...
 
template void ModelPartOperationUtilities::FillNodePointersForEntities< ModelPart::ConditionsContainerType > (std::set< CNodePointersType > &, const ModelPart::ConditionsContainerType &)
 
template void ModelPartOperationUtilities::FillNodePointersForEntities< ModelPart::ElementsContainerType > (std::set< CNodePointersType > &, const ModelPart::ElementsContainerType &)
 
template void ModelPartOperationUtilities::FillNodesFromEntities< ModelPart::ConditionType > (std::vector< ModelPart::NodeType * > &, typename std::vector< ModelPart::ConditionType * >::iterator, typename std::vector< ModelPart::ConditionType * >::iterator)
 
template void ModelPartOperationUtilities::FillNodesFromEntities< ModelPart::ElementType > (std::vector< ModelPart::NodeType * > &, typename std::vector< ModelPart::ElementType * >::iterator, typename std::vector< ModelPart::ElementType * >::iterator)
 
template void ModelPartOperationUtilities::FindNeighbourEntities< ModelPart::ConditionsContainerType > (std::vector< ModelPart::ConditionType * > &, const Flags &, ModelPart::ConditionsContainerType &)
 
template void ModelPartOperationUtilities::FindNeighbourEntities< ModelPart::ElementsContainerType > (std::vector< ModelPart::ElementType * > &, const Flags &, ModelPart::ElementsContainerType &)
 
template void ModelPartOperationUtilities::CheckEntities< ModelPart::ConditionsContainerType > (std::vector< IndexType > &, const ModelPart::ConditionsContainerType &, const std::set< CNodePointersType > &)
 
template void ModelPartOperationUtilities::CheckEntities< ModelPart::ElementsContainerType > (std::vector< IndexType > &, const ModelPart::ElementsContainerType &, const std::set< CNodePointersType > &)
 
template<>
void NormalCalculationUtils::CalculateNormals< ModelPart::ConditionsContainerType, true > (ModelPart &rModelPart, const bool EnforceGenericGeometryAlgorithm, const bool ConsiderUnitNormal, const Variable< array_1d< double, 3 >> &rNormalVariable)
 
template<>
void NormalCalculationUtils::CalculateNormals< ModelPart::ConditionsContainerType, false > (ModelPart &rModelPart, const bool EnforceGenericGeometryAlgorithm, const bool ConsiderUnitNormal, const Variable< array_1d< double, 3 >> &rNormalVariable)
 
template<>
void NormalCalculationUtils::CalculateNormals< ModelPart::ElementsContainerType, true > (ModelPart &rModelPart, const bool EnforceGenericGeometryAlgorithm, const bool ConsiderUnitNormal, const Variable< array_1d< double, 3 >> &rNormalVariable)
 
template<>
void NormalCalculationUtils::CalculateNormals< ModelPart::ElementsContainerType, false > (ModelPart &rModelPart, const bool EnforceGenericGeometryAlgorithm, const bool ConsiderUnitNormal, const Variable< array_1d< double, 3 >> &rNormalVariable)
 
template void NormalCalculationUtils::CalculateNormalsUsingGenericAlgorithm< ModelPart::ConditionsContainerType, true > (ModelPart &, const bool, const NormalVariableType &)
 
template void NormalCalculationUtils::CalculateNormalsUsingGenericAlgorithm< ModelPart::ConditionsContainerType, false > (ModelPart &, const bool, const NormalVariableType &)
 
template void NormalCalculationUtils::CalculateNormalsUsingGenericAlgorithm< ModelPart::ElementsContainerType, true > (ModelPart &, const bool, const NormalVariableType &)
 
template void NormalCalculationUtils::CalculateNormalsUsingGenericAlgorithm< ModelPart::ElementsContainerType, false > (ModelPart &, const bool, const NormalVariableType &)
 
template void NormalCalculationUtils::InitializeNormals< ModelPart::ConditionsContainerType, true > (ModelPart &, const NormalVariableType &)
 
template void NormalCalculationUtils::InitializeNormals< ModelPart::ConditionsContainerType, false > (ModelPart &, const NormalVariableType &)
 
template void NormalCalculationUtils::InitializeNormals< ModelPart::ElementsContainerType, true > (ModelPart &, const NormalVariableType &)
 
template void NormalCalculationUtils::InitializeNormals< ModelPart::ElementsContainerType, false > (ModelPart &, const NormalVariableType &)
 
template void NormalCalculationUtils::CalculateNormalsInContainer< ModelPart::ConditionsContainerType > (ModelPart &, const Variable< array_1d< double, 3 >> &)
 
template void NormalCalculationUtils::CalculateNormalsInContainer< ModelPart::ElementsContainerType > (ModelPart &, const Variable< array_1d< double, 3 >> &)
 
template void NormalCalculationUtils::CalculateUnitNormals< ModelPart::ConditionsContainerType, true > (ModelPart &, const bool, const NormalVariableType &)
 
template void NormalCalculationUtils::CalculateUnitNormals< ModelPart::ConditionsContainerType, false > (ModelPart &, const bool, const NormalVariableType &)
 
template void NormalCalculationUtils::CalculateUnitNormals< ModelPart::ElementsContainerType, true > (ModelPart &, const bool, const NormalVariableType &)
 
template void NormalCalculationUtils::CalculateUnitNormals< ModelPart::ElementsContainerType, false > (ModelPart &, const bool, const NormalVariableType &)
 
template<class TIterator , class TFunction , std::enable_if_t< std::is_base_of_v< std::input_iterator_tag, typename std::iterator_traits< TIterator >::iterator_category >, bool > = true>
void block_for_each (TIterator itBegin, TIterator itEnd, TFunction &&rFunction)
 Execute a functor on all items of a range in parallel. More...
 
template<class TReduction , class TIterator , class TFunction , std::enable_if_t< std::is_base_of_v< std::input_iterator_tag, typename std::iterator_traits< TIterator >::iterator_category >, bool > = true>
TReduction::return_type block_for_each (TIterator itBegin, TIterator itEnd, TFunction &&rFunction)
 Execute a functor on all items of a range in parallel, and perform a reduction. More...
 
template<class TIterator , class TTLS , class TFunction , std::enable_if_t< std::is_base_of_v< std::input_iterator_tag, typename std::iterator_traits< TIterator >::iterator_category >, bool > = true>
void block_for_each (TIterator itBegin, TIterator itEnd, const TTLS &rTLS, TFunction &&rFunction)
 Execute a functor with thread local storage on all items of a range in parallel. More...
 
template<class TReduction , class TIterator , class TTLS , class TFunction , std::enable_if_t< std::is_base_of_v< std::input_iterator_tag, typename std::iterator_traits< TIterator >::iterator_category >, bool > = true>
TReduction::return_type block_for_each (TIterator itBegin, TIterator itEnd, const TTLS &tls, TFunction &&rFunction)
 Execute a functor with thread local storage on all items of a range in parallel, and perform a reduction. More...
 
template<class TContainerType , class TFunctionType , std::enable_if_t<!std::is_same_v< std::iterator_traits< typename decltype(std::declval< std::remove_cv_t< TContainerType >>().begin())::value_type >, void >, bool > = true>
void block_for_each (TContainerType &&v, TFunctionType &&func)
 simplified version of the basic loop (without reduction) to enable template type deduction More...
 
template<class TReducer , class TContainerType , class TFunctionType , std::enable_if_t<!std::is_same_v< std::iterator_traits< typename decltype(std::declval< std::remove_cv_t< TContainerType >>().begin())::value_type >, void >, bool > = true>
TReducer::return_type block_for_each (TContainerType &&v, TFunctionType &&func)
 simplified version of the basic loop with reduction to enable template type deduction More...
 
template<class TContainerType , class TThreadLocalStorage , class TFunctionType , std::enable_if_t<!std::is_same_v< std::iterator_traits< typename decltype(std::declval< std::remove_cv_t< TContainerType >>().begin())::value_type >, void >, bool > = true>
void block_for_each (TContainerType &&v, const TThreadLocalStorage &tls, TFunctionType &&func)
 simplified version of the basic loop with thread local storage (TLS) to enable template type deduction More...
 
template<class TReducer , class TContainerType , class TThreadLocalStorage , class TFunctionType , std::enable_if_t<!std::is_same_v< std::iterator_traits< typename decltype(std::declval< std::remove_cv_t< TContainerType >>().begin())::value_type >, void >, bool > = true>
TReducer::return_type block_for_each (TContainerType &&v, const TThreadLocalStorage &tls, TFunctionType &&func)
 simplified version of the basic loop with reduction and thread local storage (TLS) to enable template type deduction More...
 
template<Globals::DataLocation TLocation, class TEntity >
auto MakeProxy (const TEntity &rEntity)
 Invalid template base to be specialized for valid template parameters. More...
 
template<Globals::DataLocation TLocation, class TEntity >
auto MakeProxy (TEntity &rEntity)
 Invalid template base to be specialized for valid template parameters. More...
 
template<>
auto MakeProxy< Globals::DataLocation::ProcessInfo, ModelPart > (const ModelPart &rModelPart)
 Convenience function for constructing a mutable ProcessInfo proxy from a ModelPart. More...
 
template<>
auto MakeProxy< Globals::DataLocation::ProcessInfo, ModelPart > (ModelPart &rModelPart)
 Convenience function for constructing an immutable ProcessInfo proxy from a ModelPart. More...
 
template<class T >
Quaternion< T > operator* (const Quaternion< T > &a, const Quaternion< T > &b)
 
template<class T >
std::istream & operator>> (std::istream &rIStream, Quaternion< T > &rThis)
 
template<class T >
std::ostream & operator<< (std::ostream &rOStream, const Quaternion< T > &rThis)
 
template<>
ModelPart::ElementsContainerTypeSensitivityUtilities::GetContainer< ModelPart::ElementsContainerType > (ModelPart &rModelPart)
 
template<>
ModelPart::ConditionsContainerTypeSensitivityUtilities::GetContainer< ModelPart::ConditionsContainerType > (ModelPart &rModelPart)
 
template void SensitivityUtilities::AssignEntityDerivativesToNodes< ModelPart::ElementsContainerType > (ModelPart &, const int, const Variable< Matrix > &, const std::unordered_map< int, std::vector< int >> &, const double, const Flags &, const bool)
 
template void SensitivityUtilities::AssignEntityDerivativesToNodes< ModelPart::ConditionsContainerType > (ModelPart &, const int, const Variable< Matrix > &, const std::unordered_map< int, std::vector< int >> &, const double, const Flags &, const bool)
 
template<class T >
std::ostream & operator<< (std::ostream &rOStream, const std::vector< T > &rVec)
 
template<>
void VariableRedistributionUtility::ConsistentMassMatrix< GeometryData::KratosGeometryFamily::Kratos_Linear, 2 > (BoundedMatrix< double, 2, 2 > &rMassMatrix)
 
template<>
void VariableRedistributionUtility::ConsistentMassMatrix< GeometryData::KratosGeometryFamily::Kratos_Triangle, 3 > (BoundedMatrix< double, 3, 3 > &rMassMatrix)
 
template<>
void VariableRedistributionUtility::ConsistentMassMatrix< GeometryData::KratosGeometryFamily::Kratos_Quadrilateral, 4 > (BoundedMatrix< double, 4, 4 > &rMassMatrix)
 
template<>
ModelPart::NodesContainerTypeVariableUtils::GetContainer< ModelPart::NodesContainerType > (ModelPart &rModelPart)
 
template<>
ModelPart::ElementsContainerTypeVariableUtils::GetContainer< ModelPart::ElementsContainerType > (ModelPart &rModelPart)
 
template<>
ModelPart::ConditionsContainerTypeVariableUtils::GetContainer< ModelPart::ConditionsContainerType > (ModelPart &rModelPart)
 
template<>
const ModelPart::NodesContainerTypeVariableUtils::GetContainer< ModelPart::NodesContainerType > (const ModelPart &rModelPart)
 
template<>
const ModelPart::ElementsContainerTypeVariableUtils::GetContainer< ModelPart::ElementsContainerType > (const ModelPart &rModelPart)
 
template<>
const ModelPart::ConditionsContainerTypeVariableUtils::GetContainer< ModelPart::ConditionsContainerType > (const ModelPart &rModelPart)
 
template void VariableUtils::WeightedAccumulateVariableOnNodes< double, ModelPart::ConditionsContainerType, int > (ModelPart &, const Variable< double > &, const Variable< int > &, const bool)
 
template void VariableUtils::WeightedAccumulateVariableOnNodes< double, ModelPart::ElementsContainerType, int > (ModelPart &, const Variable< double > &, const Variable< int > &, const bool)
 
template void VariableUtils::WeightedAccumulateVariableOnNodes< double, ModelPart::ConditionsContainerType, double > (ModelPart &, const Variable< double > &, const Variable< double > &, const bool)
 
template void VariableUtils::WeightedAccumulateVariableOnNodes< double, ModelPart::ElementsContainerType, double > (ModelPart &, const Variable< double > &, const Variable< double > &, const bool)
 
template std::vector< doubleVariableUtils::GetInitialPositionsVector< std::vector< double > > (const ModelPart::NodesContainerType &, const unsigned int Dimension)
 
template std::vector< doubleVariableUtils::GetCurrentPositionsVector< std::vector< double > > (const ModelPart::NodesContainerType &, const unsigned int Dimension)
 
template<class TPointType >
const GeometryData Line3DN< TPointType >::msGeometryData & msGeometryDimension (), Line3DN< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
 KRATOS_CREATE_VARIABLE (double, CHIMERA_DISTANCE)
 
 KRATOS_CREATE_VARIABLE (double, ROTATIONAL_ANGLE)
 
 KRATOS_CREATE_VARIABLE (double, ROTATIONAL_VELOCITY)
 
 KRATOS_CREATE_VARIABLE (bool, CHIMERA_INTERNAL_BOUNDARY)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (ROTATION_MESH_DISPLACEMENT)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (ROTATION_MESH_VELOCITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CHIMERA_APPLICATION, double, CHIMERA_DISTANCE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CHIMERA_APPLICATION, double, ROTATIONAL_ANGLE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CHIMERA_APPLICATION, double, ROTATIONAL_VELOCITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CHIMERA_APPLICATION, bool, CHIMERA_INTERNAL_BOUNDARY)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (CHIMERA_APPLICATION, ROTATION_MESH_DISPLACEMENT)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (CHIMERA_APPLICATION, ROTATION_MESH_VELOCITY)
 
 KRATOS_CREATE_VARIABLE (double, ROTATION_ANGLE)
 
 KRATOS_CREATE_VARIABLE (double, WAKE_DISTANCE)
 
 KRATOS_CREATE_VARIABLE (Vector, WAKE_ELEMENTAL_DISTANCES)
 
 KRATOS_CREATE_VARIABLE (Vector, WAKE_ORIGIN)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (VECTOR_TO_UPWIND_ELEMENT)
 
template<class TPrimalCondition >
std::istream & operator>> (std::istream &rIStream, AdjointPotentialWallCondition< TPrimalCondition > &rThis)
 input stream function More...
 
template<class TPrimalCondition >
std::ostream & operator<< (std::ostream &rOStream, const AdjointPotentialWallCondition< TPrimalCondition > &rThis)
 output stream function More...
 
 KRATOS_CREATE_VARIABLE (double, PREVIOUS_CYCLE)
 
 KRATOS_CREATE_VARIABLE (bool, ADVANCE_STRATEGY_APPLIED)
 
 KRATOS_CREATE_VARIABLE (bool, SYMMETRIZE_TANGENT_OPERATOR)
 
 KRATOS_CREATE_SYMMETRIC_3D_TENSOR_VARIABLE_WITH_COMPONENTS (ISOTROPIC_ANISOTROPIC_YIELD_RATIO)
 
 KRATOS_CREATE_SYMMETRIC_3D_TENSOR_VARIABLE_WITH_COMPONENTS (ORTHOTROPIC_ELASTIC_CONSTANTS)
 
 KRATOS_CREATE_VARIABLE (double, SERIAL_PARALLEL_EQUILIBRIUM_TOLERANCE)
 
std::istream & operator>> (std::istream &rIStream, ElementDeactivationProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ElementDeactivationProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SetAutomatedInitialDamageProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SetAutomatedInitialDamageProcess &rThis)
 output stream function More...
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveModel, ADD_HISTORY_VECTOR, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveModel, HISTORY_STRAIN_MEASURE, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveModel, HISTORY_STRESS_MEASURE, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveModelData, IMPLEX_ACTIVE, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveModelData, STRAIN_COMPUTED, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveModelData, STRESS_COMPUTED, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveModelData, CONSTITUTIVE_MATRIX_COMPUTED, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveModelData, PLASTIC_REGION, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveModelData, PLASTIC_RATE_REGION, 5)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveModelData, RETURN_MAPPING_COMPUTED, 6)
 
 KRATOS_CREATE_LOCAL_FLAG (ConstitutiveModelData, UPDATE_INTERNAL_VARIABLES, 7)
 
 KRATOS_CREATE_LOCAL_FLAG (BeamPointRigidContactCondition, COMPUTE_RHS_VECTOR, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (BeamPointRigidContactCondition, COMPUTE_LHS_MATRIX, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (BeamPointRigidContactCondition, COMPUTE_RHS_VECTOR_WITH_COMPONENTS, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (BeamPointRigidContactCondition, COMPUTE_LHS_MATRIX_WITH_COMPONENTS, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (RigidBodyPointLinkCondition, COMPUTE_RHS_VECTOR, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (RigidBodyPointLinkCondition, COMPUTE_LHS_MATRIX, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (PointRigidContactCondition, COMPUTE_RHS_VECTOR, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (PointRigidContactCondition, COMPUTE_LHS_MATRIX, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (PointRigidContactCondition, COMPUTE_RHS_VECTOR_WITH_COMPONENTS, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (PointRigidContactCondition, COMPUTE_LHS_MATRIX_WITH_COMPONENTS, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (RigidBodyElement, COMPUTE_RHS_VECTOR, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (RigidBodyElement, COMPUTE_LHS_MATRIX, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (ContactDomainUtilities, COMPUTE_RHS_VECTOR, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (ContactDomainUtilities, COMPUTE_LHS_MATRIX, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (ContactDomainUtilities, COMPUTE_RHS_VECTOR_WITH_COMPONENTS, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (ContactDomainUtilities, COMPUTE_LHS_MATRIX_WITH_COMPONENTS, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (ContactDomainUtilities, COMPUTE_FRICTION_FORCES, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (ContactDomainUtilities, COMPUTE_FRICTION_STIFFNESS, 5)
 
 KRATOS_CREATE_LOCAL_FLAG (ContactDomainUtilities, COMPUTE_NODAL_CONTACT_FORCES, 6)
 
 KRATOS_CREATE_VARIABLE (MasterSlaveConstraint::Pointer, CONSTRAINT_POINTER) KRATOS_CREATE_VARIABLE(double
 
REACTION_CHECK_STIFFNESS_FACTOR KRATOS_CREATE_VARIABLE (bool, CONSIDER_TESSELLATION) KRATOS_CREATE_VARIABLE(int
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION KRATOS_CREATE_VARIABLE (int, INTEGRATION_ORDER_CONTACT) KRATOS_CREATE_VARIABLE(double
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD KRATOS_CREATE_VARIABLE (double, ZERO_TOLERANCE_FACTOR) KRATOS_CREATE_VARIABLE(double
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR KRATOS_CREATE_VARIABLE (double, SLIP_THRESHOLD) KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS(AUXILIAR_COORDINATES) KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS(DELTA_COORDINATES) KRATOS_CREATE_VARIABLE(double
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR NORMAL_GAP KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (TANGENT_SLIP) KRATOS_CREATE_VARIABLE(double
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR NORMAL_GAP WEIGHTED_GAP KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (WEIGHTED_SLIP) KRATOS_CREATE_VARIABLE(double
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (WEIGHTED_VECTOR_RESIDUAL) KRATOS_CREATE_VARIABLE(bool
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED KRATOS_CREATE_VARIABLE (bool, ACTIVE_SET_CONVERGED) KRATOS_CREATE_VARIABLE(bool
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED KRATOS_CREATE_VARIABLE (double, OPERATOR_THRESHOLD) KRATOS_CREATE_VARIABLE(double
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT KRATOS_CREATE_VARIABLE (double, DYNAMIC_FACTOR) KRATOS_CREATE_VARIABLE(double
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT LAGRANGE_MULTIPLIER_CONTACT_PRESSURE KRATOS_CREATE_VARIABLE (double, AUGMENTED_NORMAL_CONTACT_PRESSURE) KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS(AUGMENTED_TANGENT_CONTACT_PRESSURE) KRATOS_CREATE_VARIABLE(int
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT LAGRANGE_MULTIPLIER_CONTACT_PRESSURE CONSIDER_NORMAL_VARIATION KRATOS_CREATE_VARIABLE (bool, ADAPT_PENALTY) KRATOS_CREATE_VARIABLE(double
 
 KRATOS_CREATE_VARIABLE (double, SCALAR_DISPLACEMENT)
 
 KRATOS_CREATE_VARIABLE (double, SCALAR_ROOT_POINT_DISPLACEMENT)
 
 KRATOS_CREATE_VARIABLE (double, SCALAR_REACTION)
 
 KRATOS_CREATE_VARIABLE (double, SCALAR_FORCE)
 
 KRATOS_CREATE_VARIABLE (double, SCALAR_VOLUME_ACCELERATION)
 
 KRATOS_CREATE_VARIABLE (std::vector< std::size_t >, NODES_ID_INDEX_MAP)
 
 KRATOS_CREATE_VARIABLE (std::vector< std::size_t >, ELEMENTS_ID_INDEX_MAP)
 
 KRATOS_CREATE_VARIABLE (int, COUPLING_ITERATION_NUMBER)
 
 KRATOS_CREATE_VARIABLE (int, INTERFACE_EQUATION_ID)
 
 KRATOS_CREATE_VARIABLE (int, EXPLICIT_EQUATION_ID)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CO_SIMULATION_APPLICATION, double, SCALAR_DISPLACEMENT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CO_SIMULATION_APPLICATION, double, SCALAR_ROOT_POINT_DISPLACEMENT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CO_SIMULATION_APPLICATION, double, SCALAR_REACTION)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CO_SIMULATION_APPLICATION, double, SCALAR_FORCE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CO_SIMULATION_APPLICATION, double, SCALAR_VOLUME_ACCELERATION)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CO_SIMULATION_APPLICATION, std::vector< std::size_t >, NODES_ID_INDEX_MAP)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CO_SIMULATION_APPLICATION, std::vector< std::size_t >, ELEMENTS_ID_INDEX_MAP)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CO_SIMULATION_APPLICATION, int, COUPLING_ITERATION_NUMBER)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CO_SIMULATION_APPLICATION, int, INTERFACE_EQUATION_ID)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CO_SIMULATION_APPLICATION, int, EXPLICIT_EQUATION_ID)
 
 KRATOS_CREATE_LOCAL_FLAG (SolidElement, COMPUTE_RHS_VECTOR, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (SolidElement, COMPUTE_LHS_MATRIX, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (SolidElement, FINALIZED_STEP, 2)
 
std::istream & operator>> (std::istream &rIStream, ApplyComponentTableProcessDam &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyComponentTableProcessDam &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamAddedMassConditionProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamAddedMassConditionProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamAzenhaHeatFluxProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamAzenhaHeatFluxProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamBofangConditionTemperatureProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamBofangConditionTemperatureProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamChemoMechanicalAgingYoungProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamChemoMechanicalAgingYoungProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamFixTemperatureConditionProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamFixTemperatureConditionProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamGroutingReferenceTemperatureProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamGroutingReferenceTemperatureProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamHydroConditionLoadProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamHydroConditionLoadProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamInputTableNodalYoungModulusProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamInputTableNodalYoungModulusProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamNodalReferenceTemperatureProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamNodalReferenceTemperatureProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamNodalYoungModulusProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamNodalYoungModulusProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamNoorzaiHeatFluxProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamNoorzaiHeatFluxProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamRandomFieldsVariableProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamRandomFieldsVariableProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamReservoirConstantTemperatureProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamReservoirConstantTemperatureProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamReservoirMonitoringTemperatureProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamReservoirMonitoringTemperatureProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamTSolAirHeatFluxProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamTSolAirHeatFluxProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamTemperaturebyDeviceProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamTemperaturebyDeviceProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamUpliftCircularConditionLoadProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamUpliftCircularConditionLoadProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamUpliftConditionLoadProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamUpliftConditionLoadProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DamWestergaardConditionLoadProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DamWestergaardConditionLoadProcess &rThis)
 output stream function More...
 
void triangulate (char *, struct triangulateio *, struct triangulateio *, struct triangulateio *)
 
void trifree (void *)
 
 KRATOS_CREATE_LOCAL_FLAG (MeshDataTransferUtilities, NODE_TO_ELEMENT, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (MeshDataTransferUtilities, ELEMENT_TO_NODE, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (MeshDataTransferUtilities, ELEMENT_TO_ELEMENT, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (MeshDataTransferUtilities, INITIALIZE_MASTER_CONDITION, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (MeshDataTransferUtilities, MASTER_ELEMENT_TO_MASTER_CONDITION, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REMESH, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REFINE, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, RECONNECT, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, TRANSFER, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, CONSTRAINED, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, CONTACT_SEARCH, 5)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, MESH_SMOOTHING, 6)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, VARIABLES_SMOOTHING, 7)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REMOVE_NODES, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REMOVE_NODES_ON_DISTANCE, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REMOVE_NODES_ON_ERROR, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REMOVE_NODES_ON_THRESHOLD, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REMOVE_BOUNDARY_NODES, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REMOVE_BOUNDARY_NODES_ON_DISTANCE, 5)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REMOVE_BOUNDARY_NODES_ON_ERROR, 6)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REMOVE_BOUNDARY_NODES_ON_THRESHOLD, 7)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REFINE_ADD_NODES, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REFINE_INSERT_NODES, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REFINE_ELEMENTS, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REFINE_ELEMENTS_ON_DISTANCE, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REFINE_ELEMENTS_ON_ERROR, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REFINE_ELEMENTS_ON_THRESHOLD, 5)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REFINE_BOUNDARY, 6)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REFINE_BOUNDARY_ON_DISTANCE, 7)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REFINE_BOUNDARY_ON_ERROR, 8)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REFINE_BOUNDARY_ON_THRESHOLD, 9)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, INITIALIZE_MESHER_INPUT, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, FINALIZE_MESHER_INPUT, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, TRANSFER_KRATOS_NODES_TO_MESHER, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, TRANSFER_KRATOS_ELEMENTS_TO_MESHER, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, TRANSFER_KRATOS_FACES_TO_MESHER, 5)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, SELECT_TESSELLATION_ELEMENTS, 6)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, KEEP_ISOLATED_NODES, 7)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, REFINE_WALL_CORNER, 8)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, NEIGHBOURS_SEARCH, 8)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, BOUNDARIES_SEARCH, 9)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, SET_DOF, 10)
 
 KRATOS_CREATE_LOCAL_FLAG (MesherUtilities, PASS_ALPHA_SHAPE, 11)
 
std::istream & operator>> (std::istream &rIStream, AnalyticRigidBodyElement &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AnalyticRigidBodyElement &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AnalyticSphericParticle &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AnalyticSphericParticle &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, BeamParticle &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const BeamParticle &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Cluster3D &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Cluster3D &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ContactInfoSphericParticle &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ContactInfoSphericParticle &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SingleSphereCluster3D &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SingleSphereCluster3D &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CylinderContinuumParticle &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CylinderContinuumParticle &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CylinderParticle &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CylinderParticle &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DiscreteElement &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DiscreteElement &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, IceContinuumParticle &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const IceContinuumParticle &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, NanoParticle &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const NanoParticle &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, PolyhedronSkinSphericParticle &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const PolyhedronSkinSphericParticle &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RigidBodyElement3D &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RigidBodyElement3D &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ShipElement3D &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ShipElement3D &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SphericContinuumParticle &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SphericContinuumParticle &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SphericParticle &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SphericParticle &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AutomaticDTProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AutomaticDTProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ControlModule2DProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ControlModule2DProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DEMIntegrationScheme &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DEMIntegrationScheme &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ForwardEulerScheme &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const ForwardEulerScheme &rThis)
 
std::istream & operator>> (std::istream &rIStream, GluedToWallScheme &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const GluedToWallScheme &rThis)
 
std::istream & operator>> (std::istream &rIStream, QuaternionIntegrationScheme &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const QuaternionIntegrationScheme &rThis)
 
std::istream & operator>> (std::istream &rIStream, RungeKuttaScheme &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const RungeKuttaScheme &rThis)
 
std::istream & operator>> (std::istream &rIStream, SymplecticEulerScheme &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const SymplecticEulerScheme &rThis)
 
std::istream & operator>> (std::istream &rIStream, TaylorScheme &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const TaylorScheme &rThis)
 
std::istream & operator>> (std::istream &rIStream, VelocityVerletScheme &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const VelocityVerletScheme &rThis)
 
std::istream & operator>> (std::istream &rIStream, ClusterInformation &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const ClusterInformation &rThis)
 
double CalculateNormalizedIndentation (SphericParticle &elem_it_1, SphericParticle &elem_it_2)
 
bool SortSubModelPartsByName (ModelPart *A, ModelPart *B)
 
std::ostream & operator<< (std::ostream &rOut, const PropertiesProxy &rTheProxies)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (TABLE_NUMBER_VELOCITY) KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS(TABLE_NUMBER_ANGULAR_VELOCITY) KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS(TABLE_NUMBER_FORCE) KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS(TABLE_NUMBER_MOMENT) KRATOS_CREATE_VARIABLE(double
 
PARTICLE_COHESION KRATOS_CREATE_VARIABLE (double, I22) KRATOS_CREATE_VARIABLE(double
 
PARTICLE_COHESION I33 KRATOS_CREATE_VARIABLE (double, BEAM_INERTIA_ROT_UNIT_LENGHT_X) KRATOS_CREATE_VARIABLE(double
 
PARTICLE_COHESION I33 BEAM_INERTIA_ROT_UNIT_LENGHT_Y KRATOS_CREATE_VARIABLE(double, BEAM_INERTIA_ROT_UNIT_LENGHT_Z) typedef std KRATOS_CREATE_VARIABLE (double, FRICTION) KRATOS_CREATE_VARIABLE(double
 
PARTICLE_COHESION I33 BEAM_INERTIA_ROT_UNIT_LENGHT_Y KRATOS_CREATE_VARIABLE(double, BEAM_INERTIA_ROT_UNIT_LENGHT_Z) typedef std K_ALPHA KRATOS_CREATE_VARIABLE (GlobalPointersVector< Element >, NEIGHBOUR_PARTICLE_BLOCK_ELEMENTS) KRATOS_CREATE_VARIABLE(GlobalPointersVector< Element >
 
PARTICLE_COHESION I33 BEAM_INERTIA_ROT_UNIT_LENGHT_Y KRATOS_CREATE_VARIABLE(double, BEAM_INERTIA_ROT_UNIT_LENGHT_Z) typedef std K_ALPHA NEIGHBOUR_PARTICLE_OF_RIGID_FACE KRATOS_CREATE_VARIABLE (double, CALCULATE_COMPUTE_NEW_RIGID_FACE_NEIGHBOURS_HISTORICAL_DATA) KRATOS_CREATE_LOCAL_FLAG(DEMFlags
 
PARTICLE_COHESION I33 BEAM_INERTIA_ROT_UNIT_LENGHT_Y KRATOS_CREATE_VARIABLE(double, BEAM_INERTIA_ROT_UNIT_LENGHT_Z) typedef std K_ALPHA NEIGHBOUR_PARTICLE_OF_RIGID_FACE KRATOS_CREATE_LOCAL_FLAG (DEMFlags, HAS_ROLLING_FRICTION, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMFlags, STICKY, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMFlags, HAS_CRITICAL_TIME, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMFlags, FIXED_VEL_X, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMFlags, FIXED_VEL_Y, 5)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMFlags, FIXED_VEL_Z, 6)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMFlags, FIXED_ANG_VEL_X, 7)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMFlags, FIXED_ANG_VEL_Y, 8)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMFlags, FIXED_ANG_VEL_Z, 9)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMFlags, BELONGS_TO_A_CLUSTER, 10)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMFlags, HAS_STRESS_TENSOR, 11)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMFlags, COPIED_STRESS_TENSOR, 12)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMFlags, COPIED_STRESS_TENSOR2, 13)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMFlags, PRINT_STRESS_TENSOR, 14)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMFlags, CUMULATIVE_ZONE, 15)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMFlags, IS_SAND_PRODUCTION, 16)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMFlags, POLYHEDRON_SKIN, 17)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (DEM_APPLICATION, TABLE_NUMBER_VELOCITY) KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS(DEM_APPLICATION
 
TABLE_NUMBER_ANGULAR_VELOCITY KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (DEM_APPLICATION, TABLE_NUMBER_FORCE) KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS(DEM_APPLICATION
 
TABLE_NUMBER_ANGULAR_VELOCITY TABLE_NUMBER_MOMENT KRATOS_DEFINE_APPLICATION_VARIABLE (DEM_APPLICATION, double, I22) KRATOS_DEFINE_APPLICATION_VARIABLE(DEM_APPLICATION
 
TABLE_NUMBER_ANGULAR_VELOCITY TABLE_NUMBER_MOMENT I33 KRATOS_DEFINE_APPLICATION_VARIABLE (DEM_APPLICATION, double, BEAM_INERTIA_ROT_UNIT_LENGHT_X) KRATOS_DEFINE_APPLICATION_VARIABLE(DEM_APPLICATION
 
TABLE_NUMBER_ANGULAR_VELOCITY TABLE_NUMBER_MOMENT I33 BEAM_INERTIA_ROT_UNIT_LENGHT_Y KRATOS_DEFINE_APPLICATION_VARIABLE(DEM_APPLICATION, double, BEAM_INERTIA_ROT_UNIT_LENGHT_Z) typedef std KRATOS_DEFINE_APPLICATION_VARIABLE (DEM_APPLICATION, double, FRICTION) KRATOS_DEFINE_APPLICATION_VARIABLE(DEM_APPLICATION
 
std::istream & operator>> (std::istream &rIStream, ControlModuleProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ControlModuleProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ApplyComponentTableProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyComponentTableProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ApplyDoubleTableProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyDoubleTableProcess &rThis)
 output stream function More...
 
 KRATOS_CREATE_VARIABLE (Matrix, STRAIN_TENSOR)
 
 KRATOS_CREATE_VARIABLE (Matrix, STRESS_TENSOR)
 
 KRATOS_CREATE_VARIABLE (Matrix, STRESS_TENSOR_INTEGRATED)
 
 KRATOS_CREATE_VARIABLE (Matrix, MATRIX_STRESS_TENSOR)
 
 KRATOS_CREATE_VARIABLE (Matrix, FIBER_STRESS_TENSOR)
 
 KRATOS_CREATE_VARIABLE (Vector, MATRIX_STRESS_VECTOR)
 
 KRATOS_CREATE_VARIABLE (Vector, FIBER_STRESS_VECTOR)
 
 KRATOS_CREATE_VARIABLE (double, YOUNG_MODULUS_FIBER)
 
 KRATOS_CREATE_VARIABLE (double, DENSITY_FIBER)
 
 KRATOS_CREATE_VARIABLE (double, POISSON_RATIO_FIBER)
 
 KRATOS_CREATE_VARIABLE (double, FIBER_VOLUMETRIC_PART)
 
 KRATOS_CREATE_VARIABLE (double, PLASTIC_UNIAXIAL_STRESS)
 
 KRATOS_CREATE_VARIABLE (double, MAX_PLASTIC_STRAIN)
 
 KRATOS_CREATE_VARIABLE (Matrix, MATRIX_STRESS_TENSOR_INTEGRATED)
 
 KRATOS_CREATE_VARIABLE (double, YIELD_STRESS_C_FIBER)
 
 KRATOS_CREATE_VARIABLE (double, YIELD_STRESS_T_FIBER)
 
 KRATOS_CREATE_VARIABLE (double, FRACTURE_ENERGY_FIBER)
 
 KRATOS_CREATE_VARIABLE (double, ACUMULATED_PLASTIC_STRAIN)
 
 KRATOS_CREATE_VARIABLE (double, EQUIVALENT_STRESS_VM)
 
 KRATOS_CREATE_VARIABLE (int, HARDENING_LAW)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, Vector, STRESS_VECTOR)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, Vector, DISPLACEMENT_INCREMENT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, YIELD_STRESS_C)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, YIELD_STRESS_T)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, int, INTERNAL_PRESSURE_ITERATION)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, int, PFEM_PRESSURE_ITERATION)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, Vector, STRESS_VECTOR_INTEGRATED)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, Vector, SMOOTHED_STRESS_VECTOR)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, std::string, YIELD_SURFACE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, Vector, STRAIN_VECTOR)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, int, TANGENT_CONSTITUTIVE_TENSOR)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, bool, DEMFEM_CONTACT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, bool, SMOOTHING)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, bool, GENERATE_DEM)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, bool, RECOMPUTE_NEIGHBOURS)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, IS_DAMAGED)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, int, RECONSTRUCT_PRESSURE_LOAD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, int, IS_DYNAMIC)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, STRESS_THRESHOLD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, INITIAL_THRESHOLD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, int, INTEGRATION_COEFFICIENT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, std::string, MAPPING_PROCEDURE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, bool, IS_DEM)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, bool, IS_SKIN)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, DEM_RADIUS)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, bool, DEM_GENERATED)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, bool, PRESSURE_EXPANDED)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, bool, INACTIVE_NODE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, int, NUMBER_OF_ACTIVE_ELEMENTS)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, bool, NODAL_FORCE_APPLIED)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, NODAL_FORCE_X)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, NODAL_FORCE_Y)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, NODAL_FORCE_Z)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, PLASTIC_UNIAXIAL_STRESS)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, MAX_PLASTIC_STRAIN)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, Vector, NODAL_STRESS_VECTOR)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, EQUIVALENT_NODAL_STRESS)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (FEM_TO_DEM_APPLICATION, EQUIVALENT_NODAL_STRESS_GRADIENT)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (FEM_TO_DEM_APPLICATION, AUXILIAR_GRADIENT)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (FEM_TO_DEM_APPLICATION, FORCE_LOAD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, Matrix, STRAIN_TENSOR)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, Matrix, STRESS_TENSOR)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, Matrix, STRESS_TENSOR_INTEGRATED)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, Matrix, MATRIX_STRESS_TENSOR)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, Matrix, FIBER_STRESS_TENSOR)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, Vector, MATRIX_STRESS_VECTOR)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, Vector, FIBER_STRESS_VECTOR)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, YOUNG_MODULUS_FIBER)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, DENSITY_FIBER)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, POISSON_RATIO_FIBER)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, FIBER_VOLUMETRIC_PART)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, Matrix, MATRIX_STRESS_TENSOR_INTEGRATED)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, YIELD_STRESS_C_FIBER)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, YIELD_STRESS_T_FIBER)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, FRACTURE_ENERGY_FIBER)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, ACUMULATED_PLASTIC_STRAIN)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, double, EQUIVALENT_STRESS_VM)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, int, HARDENING_LAW)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, bool, IS_TAKEN)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FEM_TO_DEM_APPLICATION, int, PRESSURE_ID)
 
void ComputeMidpointShapeFunctions (const Geometry< Node > &rGeometry, Vector &rN, Matrix &rDN_DX)
 
 KRATOS_CREATE_LOCAL_FLAG (EstimateDtUtility, CFL_ESTIMATION, 0)
 Local flags to determine the magnitudes for the Dt estimation. More...
 
 KRATOS_CREATE_LOCAL_FLAG (EstimateDtUtility, VISCOUS_FOURIER_ESTIMATION, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (EstimateDtUtility, THERMAL_FOURIER_ESTIMATION, 2)
 
template void FluidTestUtilities::RunEntityGetDofListTest< ModelPart::ConditionsContainerType > (const ModelPart::ConditionsContainerType &, const ProcessInfo &, const std::vector< const Variable< double > * > &)
 
template void FluidTestUtilities::RunEntityGetDofListTest< ModelPart::ElementsContainerType > (const ModelPart::ElementsContainerType &, const ProcessInfo &, const std::vector< const Variable< double > * > &)
 
template void FluidTestUtilities::RunEntityEquationIdVectorTest< ModelPart::ConditionsContainerType > (const ModelPart::ConditionsContainerType &, const ProcessInfo &, const std::vector< const Variable< double > * > &)
 
template void FluidTestUtilities::RunEntityEquationIdVectorTest< ModelPart::ElementsContainerType > (const ModelPart::ElementsContainerType &, const ProcessInfo &, const std::vector< const Variable< double > * > &)
 
template void FluidTestUtilities::RunEntityGetValuesVectorTest< ModelPart::ConditionsContainerType > (const ModelPart::ConditionsContainerType &, const std::vector< const Variable< double > * > &)
 
template void FluidTestUtilities::RunEntityGetValuesVectorTest< ModelPart::ElementsContainerType > (const ModelPart::ElementsContainerType &, const std::vector< const Variable< double > * > &)
 
template void FluidTestUtilities::RunEntityGetFirstDerivativesVectorTest< ModelPart::ConditionsContainerType > (const ModelPart::ConditionsContainerType &, const std::function< Vector(const ModelPart::NodeType &)> &)
 
template void FluidTestUtilities::RunEntityGetFirstDerivativesVectorTest< ModelPart::ElementsContainerType > (const ModelPart::ElementsContainerType &, const std::function< Vector(const ModelPart::NodeType &)> &)
 
template void FluidTestUtilities::RunEntityGetSecondDerivativesVectorTest< ModelPart::ConditionsContainerType > (const ModelPart::ConditionsContainerType &, const std::function< Vector(const ModelPart::NodeType &)> &)
 
template void FluidTestUtilities::RunEntityGetSecondDerivativesVectorTest< ModelPart::ElementsContainerType > (const ModelPart::ElementsContainerType &, const std::function< Vector(const ModelPart::NodeType &)> &)
 
template void FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::NodesContainerType, double > (ModelPart::NodesContainerType &, const Variable< double > &, const std::size_t, const double, const double)
 
template void FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::NodesContainerType, double > (ModelPart::NodesContainerType &, const Variable< double > &, const std::string &, const std::size_t, const double, const double)
 
template void FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::NodesContainerType, array_1d< double, 3 > > (ModelPart::NodesContainerType &, const Variable< array_1d< double, 3 >> &, const std::size_t, const double, const double)
 
template void FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::NodesContainerType, array_1d< double, 3 > > (ModelPart::NodesContainerType &, const Variable< array_1d< double, 3 >> &, const std::string &, const std::size_t, const double, const double)
 
template void FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ConditionsContainerType, double > (ModelPart::ConditionsContainerType &, const Variable< double > &, const std::size_t, const double, const double)
 
template void FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ConditionsContainerType, double > (ModelPart::ConditionsContainerType &, const Variable< double > &, const std::string &, const std::size_t, const double, const double)
 
template void FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ConditionsContainerType, array_1d< double, 3 > > (ModelPart::ConditionsContainerType &, const Variable< array_1d< double, 3 >> &, const std::size_t, const double, const double)
 
template void FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ConditionsContainerType, array_1d< double, 3 > > (ModelPart::ConditionsContainerType &, const Variable< array_1d< double, 3 >> &, const std::string &, const std::size_t, const double, const double)
 
template void FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ElementsContainerType, double > (ModelPart::ElementsContainerType &, const Variable< double > &, const std::size_t, const double, const double)
 
template void FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ElementsContainerType, double > (ModelPart::ElementsContainerType &, const Variable< double > &, const std::string &, const std::size_t, const double, const double)
 
template void FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ElementsContainerType, array_1d< double, 3 > > (ModelPart::ElementsContainerType &, const Variable< array_1d< double, 3 >> &, const std::size_t, const double, const double)
 
template void FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ElementsContainerType, array_1d< double, 3 > > (ModelPart::ElementsContainerType &, const Variable< array_1d< double, 3 >> &, const std::string &, const std::size_t, const double, const double)
 
 KRATOS_CREATE_VARIABLE (double, TAWSS) KRATOS_CREATE_VARIABLE(double
 
TWSS KRATOS_CREATE_VARIABLE (double, ECAP) KRATOS_CREATE_VARIABLE(double
 
TWSS RRT KRATOS_CREATE_VARIABLE (double, OSI) KRATOS_CREATE_VARIABLE(double
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (FLUID_DYNAMICS_BIOMEDICAL_APPLICATION, double, TAWSS) KRATOS_DEFINE_APPLICATION_VARIABLE(FLUID_DYNAMICS_BIOMEDICAL_APPLICATION
 
TWSS KRATOS_DEFINE_APPLICATION_VARIABLE (FLUID_DYNAMICS_BIOMEDICAL_APPLICATION, double, ECAP) KRATOS_DEFINE_APPLICATION_VARIABLE(FLUID_DYNAMICS_BIOMEDICAL_APPLICATION
 
TWSS RRT KRATOS_DEFINE_APPLICATION_VARIABLE (FLUID_DYNAMICS_BIOMEDICAL_APPLICATION, double, OSI) KRATOS_DEFINE_APPLICATION_VARIABLE(FLUID_DYNAMICS_BIOMEDICAL_APPLICATION
 
TWSS RRT WSS KRATOS_DEFINE_APPLICATION_VARIABLE (FLUID_DYNAMICS_BIOMEDICAL_APPLICATION, double, WALL_DISTANCE) KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS(FLUID_DYNAMICS_BIOMEDICAL_APPLICATION
 
TWSS RRT WSS WSS_TANGENTIAL_STRESS KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (FLUID_DYNAMICS_BIOMEDICAL_APPLICATION, WSS_NORMAL_STRESS) KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS(FLUID_DYNAMICS_BIOMEDICAL_APPLICATION
 
TWSS RRT WSS WSS_TANGENTIAL_STRESS TEMPORAL_OSI KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (FLUID_DYNAMICS_BIOMEDICAL_APPLICATION, WALL_NORMAL) KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS(FLUID_DYNAMICS_BIOMEDICAL_APPLICATION
 
std::istream & operator>> (std::istream &rIStream, ApplyConstantInterpolateLinePressureProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyConstantInterpolateLinePressureProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ApplyConstantPhreaticMultiLinePressureProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyConstantPhreaticMultiLinePressureProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ApplyPhreaticMultiLinePressureTableProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyPhreaticMultiLinePressureTableProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ApplyWriteScalarProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyWriteScalarProcess &rThis)
 output stream function More...
 
Kratos::PeriodicInterfaceProcess Process operator (std::istream &rIStream, PeriodicInterfaceProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const PeriodicInterfaceProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RetentionLaw &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RetentionLaw &rThis)
 output stream function More...
 
 KRATOS_CREATE_VARIABLE (std::string, UDSM_NAME) KRATOS_CREATE_VARIABLE(bool
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (GEO_MECHANICS_APPLICATION, std::string, UDSM_NAME) KRATOS_DEFINE_APPLICATION_VARIABLE(GEO_MECHANICS_APPLICATION
 
std::vector< ElementsContainerTypeFactorElements (ElementsContainerType const &rElements)
 Factor a collection of elements into uniform containers. More...
 
void FactorElements (ElementsContainerType const &rElements, std::vector< std::string > &rNames, std::vector< ElementsContainerType > &rFactoredElements)
 
std::vector< ConditionsContainerTypeFactorConditions (ConditionsContainerType const &rConditions)
 
void FactorConditions (ConditionsContainerType const &rConditions, std::vector< std::string > &rNames, std::vector< ConditionsContainerType > &rFactoredConditions)
 
void SplitNodesIntoLocalAndGhost (ModelPart::NodesContainerType const &rNodes, std::vector< ModelPart::NodeType * > &rLocalNodes, std::vector< ModelPart::NodeType * > &rGhostNodes)
 
void GetLocalNodes (ModelPart::NodesContainerType const &rNodes, std::vector< ModelPart::NodeType * > &rLocalNodes)
 
 KRATOS_CREATE_LOCAL_FLAG (IgaFlags, FIX_DISPLACEMENT_X, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (IgaFlags, FIX_DISPLACEMENT_Y, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (IgaFlags, FIX_DISPLACEMENT_Z, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (IgaFlags, FIX_ROTATION_X, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (IgaFlags, FIX_ROTATION_Y, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (IgaFlags, FIX_ROTATION_Z, 5)
 
template<class TSolverType , class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream & operator>> (std::istream &rIStream, EigenDenseDirectSolver< TSolverType, TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 
template<class TSolverType , class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream & operator<< (std::ostream &rOStream, const EigenDenseDirectSolver< TSolverType, TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 
template<class TSolverType , class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream & operator>> (std::istream &rIStream, EigenDirectSolver< TSolverType, TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 
template<class TSolverType , class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream & operator<< (std::ostream &rOStream, const EigenDirectSolver< TSolverType, TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream & operator>> (std::istream &rIStream, EigensystemSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream & operator<< (std::ostream &rOStream, const EigensystemSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 
template<bool TSymmetric, typename TScalarIn , typename TScalarOut >
std::istream & operator>> (std::istream &rIStream, FEASTEigensystemSolver< TSymmetric, TScalarIn, TScalarOut > &rThis)
 
template<bool TSymmetric, typename TScalarIn , typename TScalarOut >
std::ostream & operator<< (std::ostream &rOStream, const FEASTEigensystemSolver< TSymmetric, TScalarIn, TScalarOut > &rThis)
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream & operator>> (std::istream &rIStream, SpectraSymGEigsShiftSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream & operator<< (std::ostream &rOStream, const SpectraSymGEigsShiftSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 
MPI_Datatype GetMPIDatatype (const double &rValue)
 
MPI_Datatype GetMPIDatatype (const char &rValue)
 
 KRATOS_CREATE_LOCAL_FLAG (MeshingFlags, REFINED, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (MeshingFlags, TO_COARSEN, 1)
 
 KRATOS_CREATE_VARIABLE (double, AVERAGE_NODAL_ERROR)
 
 KRATOS_CREATE_VARIABLE (double, ANISOTROPIC_RATIO)
 
 KRATOS_CREATE_VARIABLE (Vector3, AUXILIAR_GRADIENT)
 
 KRATOS_CREATE_VARIABLE (Vector, AUXILIAR_HESSIAN)
 
 KRATOS_CREATE_VARIABLE (double, METRIC_SCALAR)
 
 KRATOS_CREATE_SYMMETRIC_2D_TENSOR_VARIABLE_WITH_COMPONENTS (METRIC_TENSOR_2D)
 
 KRATOS_CREATE_SYMMETRIC_3D_TENSOR_VARIABLE_WITH_COMPONENTS (METRIC_TENSOR_3D)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (AUXILIARY_FIELD)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_LINEAR_D_X)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_LINEAR_D_CX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_PLANE_SYMMETRY_D_X)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_PLANE_SYMMETRY_D_CX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (NEAREST_NEIGHBOUR_POINT)
 
 KRATOS_CREATE_VARIABLE (double, NEAREST_NEIGHBOUR_DIST)
 
 KRATOS_CREATE_VARIABLE (int, NEAREST_NEIGHBOUR_COND_ID)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_STRAIN_ENERGY_1_D_X)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_STRAIN_ENERGY_1_D_CX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_STRAIN_ENERGY_2_D_X)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_STRAIN_ENERGY_2_D_CX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_STRAIN_ENERGY_3_D_X)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_STRAIN_ENERGY_3_D_CX)
 
 KRATOS_CREATE_VARIABLE (double, D_STRAIN_ENERGY_1_D_FD)
 
 KRATOS_CREATE_VARIABLE (double, D_STRAIN_ENERGY_1_D_CD)
 
 KRATOS_CREATE_VARIABLE (double, D_STRAIN_ENERGY_2_D_FD)
 
 KRATOS_CREATE_VARIABLE (double, D_STRAIN_ENERGY_2_D_CD)
 
 KRATOS_CREATE_VARIABLE (double, D_STRAIN_ENERGY_3_D_FD)
 
 KRATOS_CREATE_VARIABLE (double, D_STRAIN_ENERGY_3_D_CD)
 
 KRATOS_CREATE_VARIABLE (double, D_STRAIN_ENERGY_1_D_FT)
 
 KRATOS_CREATE_VARIABLE (double, D_STRAIN_ENERGY_1_D_CT)
 
 KRATOS_CREATE_VARIABLE (double, D_STRAIN_ENERGY_2_D_FT)
 
 KRATOS_CREATE_VARIABLE (double, D_STRAIN_ENERGY_2_D_CT)
 
 KRATOS_CREATE_VARIABLE (double, D_STRAIN_ENERGY_3_D_FT)
 
 KRATOS_CREATE_VARIABLE (double, D_STRAIN_ENERGY_3_D_CT)
 
 KRATOS_CREATE_VARIABLE (double, D_INTERFACE_D_FD)
 
 KRATOS_CREATE_VARIABLE (double, D_INTERFACE_D_CD)
 
 KRATOS_CREATE_VARIABLE (double, D_PARTITION_MASS_D_FD)
 
 KRATOS_CREATE_VARIABLE (double, D_PARTITION_MASS_D_CD)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_MASS_D_X)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_MASS_D_CX)
 
 KRATOS_CREATE_VARIABLE (double, D_MASS_D_FT)
 
 KRATOS_CREATE_VARIABLE (double, D_MASS_D_CT)
 
 KRATOS_CREATE_VARIABLE (double, D_MASS_D_PD)
 
 KRATOS_CREATE_VARIABLE (double, D_MASS_D_FD)
 
 KRATOS_CREATE_VARIABLE (double, D_MASS_D_CD)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_MAX_OVERHANG_ANGLE_D_X)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_MAX_OVERHANG_ANGLE_D_CX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_STRESS_D_X)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_STRESS_D_CX)
 
 KRATOS_CREATE_VARIABLE (double, D_STRESS_D_FD)
 
 KRATOS_CREATE_VARIABLE (double, D_STRESS_D_CD)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (SX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (CX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_CX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (D_X)
 
 KRATOS_CREATE_VARIABLE (double, PT)
 
 KRATOS_CREATE_VARIABLE (double, PPT)
 
 KRATOS_CREATE_VARIABLE (double, FT)
 
 KRATOS_CREATE_VARIABLE (double, CT)
 
 KRATOS_CREATE_VARIABLE (double, D_CT)
 
 KRATOS_CREATE_VARIABLE (double, D_PT)
 
 KRATOS_CREATE_VARIABLE (double, D_PT_D_FT)
 
 KRATOS_CREATE_VARIABLE (double, D_PPT_D_FT)
 
 KRATOS_CREATE_VARIABLE (double, PD)
 
 KRATOS_CREATE_VARIABLE (double, PE)
 
 KRATOS_CREATE_VARIABLE (double, D_PD_D_FD)
 
 KRATOS_CREATE_VARIABLE (double, D_PE_D_FD)
 
 KRATOS_CREATE_VARIABLE (double, FD)
 
 KRATOS_CREATE_VARIABLE (double, CD)
 
 KRATOS_CREATE_VARIABLE (double, D_CD)
 
 KRATOS_CREATE_VARIABLE (double, D_PD)
 
 KRATOS_CREATE_VARIABLE (Matrix, HELMHOLTZ_MASS_MATRIX)
 
 KRATOS_CREATE_VARIABLE (double, HELMHOLTZ_SURF_RADIUS_SHAPE)
 
 KRATOS_CREATE_VARIABLE (double, HELMHOLTZ_BULK_RADIUS_SHAPE)
 
 KRATOS_CREATE_VARIABLE (bool, COMPUTE_CONTROL_POINTS_SHAPE)
 
 KRATOS_CREATE_VARIABLE (double, ELEMENT_STRAIN_ENERGY)
 
 KRATOS_CREATE_VARIABLE (double, HELMHOLTZ_SURF_POISSON_RATIO_SHAPE)
 
 KRATOS_CREATE_VARIABLE (double, HELMHOLTZ_BULK_POISSON_RATIO_SHAPE)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (HELMHOLTZ_VARS_SHAPE)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (HELMHOLTZ_SOURCE_SHAPE)
 
 KRATOS_CREATE_VARIABLE (double, HELMHOLTZ_VAR_THICKNESS)
 
 KRATOS_CREATE_VARIABLE (double, HELMHOLTZ_SOURCE_THICKNESS)
 
 KRATOS_CREATE_VARIABLE (double, HELMHOLTZ_RADIUS_THICKNESS)
 
 KRATOS_CREATE_VARIABLE (double, HELMHOLTZ_VAR_DENSITY)
 
 KRATOS_CREATE_VARIABLE (double, HELMHOLTZ_SOURCE_DENSITY)
 
 KRATOS_CREATE_VARIABLE (double, HELMHOLTZ_RADIUS_DENSITY)
 
 KRATOS_CREATE_VARIABLE (bool, COMPUTE_CONTROL_DENSITIES)
 
 KRATOS_CREATE_VARIABLE (bool, COMPUTE_HELMHOLTZ_INVERSE)
 
 KRATOS_CREATE_VARIABLE (bool, HELMHOLTZ_INTEGRATED_FIELD)
 
 KRATOS_CREATE_VARIABLE (double, HELMHOLTZ_RADIUS)
 
 KRATOS_CREATE_VARIABLE (double, HELMHOLTZ_SCALAR)
 
 KRATOS_CREATE_VARIABLE (double, HELMHOLTZ_SCALAR_SOURCE)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (HELMHOLTZ_VECTOR)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (HELMHOLTZ_VECTOR_SOURCE)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (ADJOINT_RHS)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (SHAPE)
 
 KRATOS_CREATE_VARIABLE (double, CROSS_AREA)
 
 KRATOS_CREATE_VARIABLE (double, DENSITY_SENSITIVITY)
 
 KRATOS_CREATE_VARIABLE (double, THICKNESS_SENSITIVITY)
 
 KRATOS_CREATE_VARIABLE (double, CROSS_AREA_SENSITIVITY)
 
 KRATOS_CREATE_VARIABLE (double, YOUNG_MODULUS_SENSITIVITY)
 
 KRATOS_CREATE_VARIABLE (double, POISSON_RATIO_SENSITIVITY)
 
 KRATOS_CREATE_VARIABLE (double, TEMPORARY_SCALAR_VARIABLE_1)
 
 KRATOS_CREATE_VARIABLE (double, TEMPORARY_SCALAR_VARIABLE_2)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (TEMPORARY_ARRAY3_VARIABLE_1)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (TEMPORARY_ARRAY3_VARIABLE_2)
 
 KRATOS_CREATE_VARIABLE (std::vector< std::string >, MODEL_PART_STATUS)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, AUXILIARY_FIELD)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_LINEAR_D_X)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_LINEAR_D_CX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_PLANE_SYMMETRY_D_X)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_PLANE_SYMMETRY_D_CX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, NEAREST_NEIGHBOUR_POINT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, NEAREST_NEIGHBOUR_DIST)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, int, NEAREST_NEIGHBOUR_COND_ID)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_STRAIN_ENERGY_1_D_X)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_STRAIN_ENERGY_1_D_CX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_STRAIN_ENERGY_2_D_X)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_STRAIN_ENERGY_2_D_CX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_STRAIN_ENERGY_3_D_X)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_STRAIN_ENERGY_3_D_CX)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_STRAIN_ENERGY_1_D_FD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_STRAIN_ENERGY_1_D_CD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_STRAIN_ENERGY_2_D_FD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_STRAIN_ENERGY_2_D_CD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_STRAIN_ENERGY_3_D_FD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_STRAIN_ENERGY_3_D_CD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_STRAIN_ENERGY_1_D_FT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_STRAIN_ENERGY_1_D_CT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_STRAIN_ENERGY_2_D_FT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_STRAIN_ENERGY_2_D_CT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_STRAIN_ENERGY_3_D_FT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_STRAIN_ENERGY_3_D_CT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_INTERFACE_D_FD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_INTERFACE_D_CD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_PARTITION_MASS_D_FD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_PARTITION_MASS_D_CD)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_MASS_D_X)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_MASS_D_CX)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_MASS_D_FT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_MASS_D_CT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_MASS_D_PD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_MASS_D_FD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_MASS_D_CD)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_MAX_OVERHANG_ANGLE_D_X)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_MAX_OVERHANG_ANGLE_D_CX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_STRESS_D_X)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_STRESS_D_CX)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_STRESS_D_FD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_STRESS_D_CD)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_MAX_STRESS_D_X)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_MAX_STRESS_D_CX)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_MAX_STRESS_D_PT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_MAX_STRESS_D_CT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_MAX_STRESS_D_PD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_MAX_STRESS_D_CD)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_MAX_STRES_D_X)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_MAX_STRES_D_CX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, CX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, SX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_CX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, D_X)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, PT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, PPT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, FT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, CT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_CT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_PT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_PT_D_FT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_PPT_D_FT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, PD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, PE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_PD_D_FD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_PE_D_FD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, FD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, CD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_CD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, D_PD)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, ADJOINT_RHS)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, Matrix, HELMHOLTZ_MASS_MATRIX)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, HELMHOLTZ_SURF_RADIUS_SHAPE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, HELMHOLTZ_BULK_RADIUS_SHAPE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, bool, COMPUTE_CONTROL_POINTS_SHAPE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, ELEMENT_STRAIN_ENERGY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, HELMHOLTZ_SURF_POISSON_RATIO_SHAPE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, HELMHOLTZ_BULK_POISSON_RATIO_SHAPE)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, HELMHOLTZ_VARS_SHAPE)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, HELMHOLTZ_SOURCE_SHAPE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, HELMHOLTZ_VAR_THICKNESS)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, HELMHOLTZ_SOURCE_THICKNESS)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, HELMHOLTZ_RADIUS_THICKNESS)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, HELMHOLTZ_VAR_DENSITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, HELMHOLTZ_SOURCE_DENSITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, HELMHOLTZ_RADIUS_DENSITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, bool, COMPUTE_CONTROL_DENSITIES)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, SHAPE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, CROSS_AREA)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, DENSITY_SENSITIVITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, THICKNESS_SENSITIVITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, CROSS_AREA_SENSITIVITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, YOUNG_MODULUS_SENSITIVITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, POISSON_RATIO_SENSITIVITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, bool, COMPUTE_HELMHOLTZ_INVERSE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, bool, HELMHOLTZ_INTEGRATED_FIELD)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, HELMHOLTZ_RADIUS)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, HELMHOLTZ_SCALAR)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, HELMHOLTZ_SCALAR_SOURCE)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, HELMHOLTZ_VECTOR)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, HELMHOLTZ_VECTOR_SOURCE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, TEMPORARY_SCALAR_VARIABLE_1)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, double, TEMPORARY_SCALAR_VARIABLE_2)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, TEMPORARY_ARRAY3_VARIABLE_1)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (OPTIMIZATION_APPLICATION, TEMPORARY_ARRAY3_VARIABLE_2)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (OPTIMIZATION_APPLICATION, std::vector< std::string >, MODEL_PART_STATUS)
 
 KRATOS_CREATE_LOCAL_FLAG (ParticleFlowRule, IMPLEX_ACTIVE, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (ParticleFlowRule, PLASTIC_REGION, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (ParticleFlowRule, PLASTIC_RATE_REGION, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (ParticleFlowRule, RETURN_MAPPING_COMPUTED, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (MPMUpdatedLagrangian, COMPUTE_RHS_VECTOR, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (MPMUpdatedLagrangian, COMPUTE_LHS_MATRIX, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (MPMUpdatedLagrangian, COMPUTE_RHS_VECTOR_WITH_COMPONENTS, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (MPMUpdatedLagrangian, COMPUTE_LHS_MATRIX_WITH_COMPONENTS, 3)
 
template<unsigned int TDim>
class Kratos::MoveParticleUtilityDiffFluidOnly FindNodeOnMesh (array_1d< double, 3 > &position, array_1d< double, TDim+1 > &N, Element::Pointer &pelement, ResultIteratorType result_begin, const unsigned int MaxNumberOfResults)
 
bool CalculatePosition (Geometry< Node > &geom, const double xc, const double yc, const double zc, array_1d< double, 3 > &N)
 
bool CalculatePosition (Geometry< Node > &geom, const double xc, const double yc, const double zc, array_1d< double, 4 > &N)
 
double CalculateVol (const double x0, const double y0, const double x1, const double y1, const double x2, const double y2)
 
double CalculateVol (const double x0, const double y0, const double z0, const double x1, const double y1, const double z1, const double x2, const double y2, const double z2, const double x3, const double y3, const double z3)
 
 KRATOS_CREATE_VARIABLE (double, PRESS_DISCONTINUITY)
 
 KRATOS_CREATE_LOCAL_FLAG (FluidElement, COMPUTE_RHS_VECTOR, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (FluidElement, COMPUTE_LHS_MATRIX, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (FluidElement, FINALIZED_STEP, 2)
 
std::istream & operator>> (std::istream &rIStream, LagrangianRotationProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const LagrangianRotationProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SetDummyPropertyForRigidElementsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SetDummyPropertyForRigidElementsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SetMaterialPropertiesForThermalCouplingProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SetMaterialPropertiesForThermalCouplingProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SetMeshVelocityForThermalCouplingProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SetMeshVelocityForThermalCouplingProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, UpdateThermalModelPartProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const UpdateThermalModelPartProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const PfemFluidGidIO<> &rThis)
 
 KRATOS_CREATE_LOCAL_FLAG (FlowRule, IMPLEX_ACTIVE, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (FlowRule, PLASTIC_REGION, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (FlowRule, PLASTIC_RATE_REGION, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (FlowRule, RETURN_MAPPING_COMPUTED, 3)
 
std::istream & operator>> (std::istream &rIStream, ApplyConstantHydrostaticPressureProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyConstantHydrostaticPressureProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ApplyHydrostaticPressureTableProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyHydrostaticPressureTableProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, PeriodicInterfaceProcess &rThis)
 input stream function More...
 
std::istream & operator>> (std::istream &rIStream, PoromechanicsFaceLoadControlModuleProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const PoromechanicsFaceLoadControlModuleProcess &rThis)
 output stream function More...
 
 KRATOS_CREATE_LOCAL_FLAG (MeshMovingModeler, TO_COPY, 1)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHALLOW_WATER_APPLICATION, double, BATHYMETRY) KRATOS_DEFINE_APPLICATION_VARIABLE(SHALLOW_WATER_APPLICATION
 
TOPOGRAPHY KRATOS_DEFINE_APPLICATION_VARIABLE (SHALLOW_WATER_APPLICATION, double, FROUDE) KRATOS_DEFINE_APPLICATION_VARIABLE(SHALLOW_WATER_APPLICATION
 
TOPOGRAPHY RAIN KRATOS_DEFINE_APPLICATION_VARIABLE (SHALLOW_WATER_APPLICATION, double, MANNING) KRATOS_DEFINE_APPLICATION_VARIABLE(SHALLOW_WATER_APPLICATION
 
TOPOGRAPHY RAIN CHEZY KRATOS_DEFINE_APPLICATION_VARIABLE (SHALLOW_WATER_APPLICATION, double, DRY_HEIGHT) KRATOS_DEFINE_APPLICATION_VARIABLE(SHALLOW_WATER_APPLICATION
 
TOPOGRAPHY RAIN CHEZY RELATIVE_DRY_HEIGHT KRATOS_DEFINE_APPLICATION_VARIABLE (SHALLOW_WATER_APPLICATION, double, DRY_DISCHARGE_PENALTY) KRATOS_DEFINE_APPLICATION_VARIABLE(SHALLOW_WATER_APPLICATION
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (NORMALIZED_SURFACE_NORMAL)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DF1DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DF1DX_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC1DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC2DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC3DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC4DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC5DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC6DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC7DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC8DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC9DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC1DX_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC2DX_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC3DX_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC4DX_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC5DX_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC6DX_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC7DX_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC8DX_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC9DX_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (SEARCH_DIRECTION)
 
 KRATOS_CREATE_VARIABLE (double, INV_HESSIAN)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (CORRECTION)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (PROJECTION)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (CONTROL_POINT_UPDATE)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (CONTROL_POINT_CHANGE)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (SHAPE_UPDATE)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (SHAPE_CHANGE)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (MESH_CHANGE)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DAMPING_FACTOR)
 
 KRATOS_CREATE_VARIABLE (int, MAPPING_ID)
 
 KRATOS_CREATE_VARIABLE (double, VERTEX_MORPHING_RADIUS)
 
 KRATOS_CREATE_VARIABLE (double, VERTEX_MORPHING_RADIUS_RAW)
 
 KRATOS_CREATE_VARIABLE (double, GAUSSIAN_CURVATURE)
 
 KRATOS_CREATE_VARIABLE (double, MAX_NEIGHBOUR_DISTANCE)
 
 KRATOS_CREATE_VARIABLE (double, ALPHA)
 
 KRATOS_CREATE_VARIABLE (double, ALPHA_MAPPED)
 
 KRATOS_CREATE_VARIABLE (double, DF1DALPHA)
 
 KRATOS_CREATE_VARIABLE (double, DF1DALPHA_MAPPED)
 
 KRATOS_CREATE_VARIABLE (double, DPDALPHA)
 
 KRATOS_CREATE_VARIABLE (double, DPDALPHA_MAPPED)
 
 KRATOS_CREATE_VARIABLE (double, DLDALPHA)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (BEAD_DIRECTION)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DP1DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DPF1DX)
 
 KRATOS_CREATE_VARIABLE (double, SCALAR_VARIABLE)
 
 KRATOS_CREATE_VARIABLE (double, SCALAR_VARIABLE_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (VECTOR_VARIABLE)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (VECTOR_VARIABLE_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (BACKGROUND_COORDINATE)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (BACKGROUND_NORMAL)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (OUT_OF_PLANE_DELTA)
 
 KRATOS_CREATE_VARIABLE (bool, CONSIDER_FACE_ANGLE)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (HEATMAP_DF1DX)
 
 KRATOS_CREATE_VARIABLE (double, HEATMAP_DF1DALPHA)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (HEATMAP_DC1DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (HEATMAP_DC2DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (HEATMAP_DC3DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (HEATMAP_DC4DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (HEATMAP_DC5DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (HEATMAP_DC6DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (HEATMAP_DC7DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (HEATMAP_DC8DX)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (HEATMAP_DC9DX)
 
 KRATOS_CREATE_VARIABLE (double, HEATMAP_MAX)
 
 KRATOS_CREATE_VARIABLE (double, HEATMAP_L2)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DF1DX_WEIGHTED)
 
 KRATOS_CREATE_VARIABLE (double, DF1DALPHA_WEIGHTED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC1DX_WEIGHTED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC2DX_WEIGHTED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC3DX_WEIGHTED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC4DX_WEIGHTED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC5DX_WEIGHTED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC6DX_WEIGHTED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC7DX_WEIGHTED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC8DX_WEIGHTED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC9DX_WEIGHTED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DF1DX_WEIGHTED_MAPPED)
 
 KRATOS_CREATE_VARIABLE (double, DF1DALPHA_WEIGHTED_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC1DX_WEIGHTED_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC2DX_WEIGHTED_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC3DX_WEIGHTED_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC4DX_WEIGHTED_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC5DX_WEIGHTED_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC6DX_WEIGHTED_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC7DX_WEIGHTED_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC8DX_WEIGHTED_MAPPED)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (DC9DX_WEIGHTED_MAPPED)
 
 KRATOS_CREATE_LOCAL_FLAG (BoundaryCondition, COMPUTE_RHS_VECTOR, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (BoundaryCondition, COMPUTE_LHS_MATRIX, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (BeamElement, COMPUTE_RHS_VECTOR, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (BeamElement, COMPUTE_LHS_MATRIX, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (BeamElement, FINALIZED_STEP, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (SmallDisplacementBeamElement3D2N, COMPUTE_RHS_VECTOR, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (SmallDisplacementBeamElement3D2N, COMPUTE_LHS_MATRIX, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (ThermalElement, COMPUTE_RHS_VECTOR, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (ThermalElement, COMPUTE_LHS_MATRIX, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (SolidShellElementSprism3D6N, COMPUTE_RHS_VECTOR, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (SolidShellElementSprism3D6N, COMPUTE_LHS_MATRIX, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (SolidShellElementSprism3D6N, COMPUTE_RHS_VECTOR_WITH_COMPONENTS, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (SolidShellElementSprism3D6N, COMPUTE_LHS_MATRIX_WITH_COMPONENTS, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (SolidShellElementSprism3D6N, EAS_IMPLICIT_EXPLICIT, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (SolidShellElementSprism3D6N, TOTAL_UPDATED_LAGRANGIAN, 5)
 
 KRATOS_CREATE_LOCAL_FLAG (SolidShellElementSprism3D6N, QUADRATIC_ELEMENT, 6)
 
 KRATOS_CREATE_LOCAL_FLAG (SolidShellElementSprism3D6N, EXPLICIT_RHS_COMPUTATION, 7)
 
std::istream & operator>> (std::istream &rIStream, ImposeZStrainProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ImposeZStrainProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SetAutomatedInitialVariableProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SetAutomatedInitialVariableProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SetCartesianLocalAxesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SetCartesianLocalAxesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SetCylindricalLocalAxesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SetCylindricalLocalAxesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SetSphericalLocalAxesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SetSphericalLocalAxesProcess &rThis)
 output stream function More...
 
double GetFromProperty (const Properties &rThisProperties, Variable< double > &rVariable)
 
 KRATOS_CREATE_VARIABLE (int, INTEGRATION_ORDER)
 
 KRATOS_CREATE_VARIABLE (double, ALPHA_EAS)
 
 KRATOS_CREATE_VARIABLE (bool, CONSIDER_IMPLICIT_EAS_SPRISM_ELEMENT)
 
 KRATOS_CREATE_VARIABLE (bool, CONSIDER_TOTAL_LAGRANGIAN_SPRISM_ELEMENT)
 
 KRATOS_CREATE_VARIABLE (bool, PURE_EXPLICIT_RHS_COMPUTATION)
 
 KRATOS_CREATE_VARIABLE (bool, RESET_EQUATION_IDS)
 
 KRATOS_CREATE_VARIABLE (double, ANG_ROT)
 
 KRATOS_CREATE_VARIABLE (bool, CONSIDER_QUADRATIC_SPRISM_ELEMENT)
 
 KRATOS_CREATE_VARIABLE (Vector, HENCKY_STRAIN_VECTOR)
 
 KRATOS_CREATE_VARIABLE (Matrix, HENCKY_STRAIN_TENSOR)
 
 KRATOS_CREATE_VARIABLE (Matrix, REFERENCE_DEFORMATION_GRADIENT)
 
 KRATOS_CREATE_VARIABLE (double, REFERENCE_DEFORMATION_GRADIENT_DETERMINANT)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (ADJOINT_CURVATURE)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (ADJOINT_STRAIN)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (POINT_LOAD_SENSITIVITY)
 
 KRATOS_CREATE_VARIABLE (double, I22_SENSITIVITY)
 
 KRATOS_CREATE_VARIABLE (double, I33_SENSITIVITY)
 
 KRATOS_CREATE_VARIABLE (double, AREA_EFFECTIVE_Y_SENSITIVITY)
 
 KRATOS_CREATE_VARIABLE (double, AREA_EFFECTIVE_Z_SENSITIVITY)
 
 KRATOS_CREATE_VARIABLE (bool, IS_ADJOINT)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (NODAL_DISPLACEMENT_STIFFNESS_SENSITIVITY)
 
 KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS (NODAL_ROTATIONAL_STIFFNESS_SENSITIVITY)
 
 KRATOS_CREATE_VARIABLE (int, TRACED_STRESS_TYPE)
 
 KRATOS_CREATE_VARIABLE (Matrix, STRESS_DISP_DERIV_ON_NODE)
 
 KRATOS_CREATE_VARIABLE (Matrix, STRESS_DISP_DERIV_ON_GP)
 
 KRATOS_CREATE_VARIABLE (Matrix, STRESS_DESIGN_DERIVATIVE_ON_NODE)
 
 KRATOS_CREATE_VARIABLE (Matrix, STRESS_DESIGN_DERIVATIVE_ON_GP)
 
 KRATOS_CREATE_VARIABLE (Vector, STRESS_ON_GP)
 
 KRATOS_CREATE_VARIABLE (Vector, STRESS_ON_NODE)
 
 KRATOS_CREATE_VARIABLE (std::string, DESIGN_VARIABLE_NAME)
 
std::istream & operator>> (std::istream &rIStream, ApplyRigidRotationProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyRigidRotationProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, HybridBashforthScheme &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const HybridBashforthScheme &rThis)
 
std::istream & operator>> (std::istream &rIStream, SymplecticEulerOldVelocityScheme &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const SymplecticEulerOldVelocityScheme &rThis)
 
std::istream & operator>> (std::istream &rIStream, TerminalVelocityScheme &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const TerminalVelocityScheme &rThis)
 
SpaceTimeSet::Pointer SetUnion (SpaceTimeSet::Pointer set_1, SpaceTimeSet::Pointer set_2)
 
SpaceTimeSet::Pointer SetIntersection (SpaceTimeSet::Pointer set_1, SpaceTimeSet::Pointer set_2)
 
std::istream & operator>> (std::istream &rIStream, DirectConductionBOBComplete &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const DirectConductionBOBComplete &rThis)
 
std::istream & operator>> (std::istream &rIStream, DirectConductionBOBModified &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const DirectConductionBOBModified &rThis)
 
std::istream & operator>> (std::istream &rIStream, DirectConductionBOBSimple &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const DirectConductionBOBSimple &rThis)
 
std::istream & operator>> (std::istream &rIStream, DirectConductionCollision &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const DirectConductionCollision &rThis)
 
std::istream & operator>> (std::istream &rIStream, DirectConductionModel &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const DirectConductionModel &rThis)
 
std::istream & operator>> (std::istream &rIStream, DirectConductionPipe &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const DirectConductionPipe &rThis)
 
std::istream & operator>> (std::istream &rIStream, IndirectConductionModel &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const IndirectConductionModel &rThis)
 
std::istream & operator>> (std::istream &rIStream, IndirectConductionSurroundLayer &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const IndirectConductionSurroundLayer &rThis)
 
std::istream & operator>> (std::istream &rIStream, IndirectConductionVargas &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const IndirectConductionVargas &rThis)
 
std::istream & operator>> (std::istream &rIStream, IndirectConductionVoronoiA &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const IndirectConductionVoronoiA &rThis)
 
std::istream & operator>> (std::istream &rIStream, IndirectConductionVoronoiB &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const IndirectConductionVoronoiB &rThis)
 
std::istream & operator>> (std::istream &rIStream, ConvectionModel &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const ConvectionModel &rThis)
 
std::istream & operator>> (std::istream &rIStream, NusseltGunn &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const NusseltGunn &rThis)
 
std::istream & operator>> (std::istream &rIStream, NusseltHanzMarshall &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const NusseltHanzMarshall &rThis)
 
std::istream & operator>> (std::istream &rIStream, NusseltLiMason &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const NusseltLiMason &rThis)
 
std::istream & operator>> (std::istream &rIStream, NusseltWhitaker &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const NusseltWhitaker &rThis)
 
std::istream & operator>> (std::istream &rIStream, GenerationDissipation &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const GenerationDissipation &rThis)
 
std::istream & operator>> (std::istream &rIStream, GenerationModel &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const GenerationModel &rThis)
 
std::istream & operator>> (std::istream &rIStream, HeatExchangeMechanism &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const HeatExchangeMechanism &rThis)
 
std::istream & operator>> (std::istream &rIStream, HeatGenerationMechanism &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const HeatGenerationMechanism &rThis)
 
std::istream & operator>> (std::istream &rIStream, RadiationContinuumKrause &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const RadiationContinuumKrause &rThis)
 
std::istream & operator>> (std::istream &rIStream, RadiationContinuumZhou &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const RadiationContinuumZhou &rThis)
 
std::istream & operator>> (std::istream &rIStream, RadiationModel &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const RadiationModel &rThis)
 
std::istream & operator>> (std::istream &rIStream, RealContactLu &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const RealContactLu &rThis)
 
std::istream & operator>> (std::istream &rIStream, RealContactModel &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const RealContactModel &rThis)
 
std::istream & operator>> (std::istream &rIStream, RealContactMorris &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const RealContactMorris &rThis)
 
std::istream & operator>> (std::istream &rIStream, RealContactZhou &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const RealContactZhou &rThis)
 
std::istream & operator>> (std::istream &rIStream, ThermalSphericParticle &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const ThermalSphericParticle &rThis)
 
std::istream & operator>> (std::istream &rIStream, ThermalDEMIntegrationScheme &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const ThermalDEMIntegrationScheme &rThis)
 
std::istream & operator>> (std::istream &rIStream, ThermalForwardEulerScheme &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const ThermalForwardEulerScheme &rThis)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMThermalFlags, IS_ADIABATIC, 18)
 
 KRATOS_CREATE_LOCAL_FLAG (DEMThermalFlags, IS_SINTERING, 19)
 
void RegisterTrilinosLinearSolvers ()
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream & operator<< (std::ostream &rOStream, const AmgclMPISchurComplementSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 
void AMGCLSolve (int block_size, TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::MatrixType &rA, TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::VectorType &rX, TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::VectorType &rB, TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::IndexType &rIterationNumber, double &rResidual, boost::property_tree::ptree amgclParams, int verbosity_level, bool use_gpgpu)
 
void AMGCLScalarSolve (TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::MatrixType &rA, TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::VectorType &rX, TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::VectorType &rB, TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::IndexType &rIterationNumber, double &rResidual, const boost::property_tree::ptree &amgclParams, int verbosity_level, bool use_gpgpu)
 
template<int TBlockSize>
void AMGCLBlockSolve (TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::MatrixType &rA, TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::VectorType &rX, TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::VectorType &rB, TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::IndexType &rIterationNumber, double &rResidual, boost::property_tree::ptree amgclParams, int verbosity_level, bool use_gpgpu)
 
Input/Output funcitons
std::istream & operator>> (std::istream &rIStream, LinearMasterSlaveConstraint &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const LinearMasterSlaveConstraint &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SlipConstraint &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SlipConstraint &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ContactMasterSlaveConstraint &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ContactMasterSlaveConstraint &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ShellCrossSection &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const ShellCrossSection &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, ShellCrossSection &rThis)
 
Input and output
template<class TDataType >
std::istream & operator>> (std::istream &rIStream, CsrMatrix< TDataType > &rThis)
 input stream function More...
 
template<class TDataType >
std::ostream & operator<< (std::ostream &rOStream, const CsrMatrix< TDataType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DataValueContainer &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DataValueContainer &rThis)
 output stream function More...
 
template<class TDataType >
std::istream & operator>> (std::istream &rIStream, DistributedCsrMatrix< TDataType > &rThis)
 input stream function More...
 
template<class TDataType >
std::ostream & operator<< (std::ostream &rOStream, const DistributedCsrMatrix< TDataType > &rThis)
 output stream function More...
 
template<class TDataType , class TIndexType >
std::istream & operator>> (std::istream &rIStream, DistributedNumbering< TIndexType > &rThis)
 input stream function More...
 
template<class TDataType , class TIndexType >
std::ostream & operator<< (std::ostream &rOStream, const DistributedNumbering< TIndexType > &rThis)
 output stream function More...
 
template<class TIndexType >
std::istream & operator>> (std::istream &rIStream, DistributedSparseGraph< TIndexType > &rThis)
 input stream function More...
 
template<class TIndexType >
std::ostream & operator<< (std::ostream &rOStream, const DistributedSparseGraph< TIndexType > &rThis)
 output stream function More...
 
template<class TDataType , class TIndexType >
std::istream & operator>> (std::istream &rIStream, DistributedSystemVector< TDataType, TIndexType > &rThis)
 input stream function More...
 
template<class TDataType , class TIndexType >
std::ostream & operator<< (std::ostream &rOStream, const DistributedSystemVector< TDataType, TIndexType > &rThis)
 output stream function More...
 
template<class TIndexType >
std::istream & operator>> (std::istream &rIStream, DistributedVectorExporter< TIndexType > &rThis)
 input stream function More...
 
template<class TIndexType >
std::ostream & operator<< (std::ostream &rOStream, const DistributedVectorExporter< TIndexType > &rThis)
 output stream function More...
 
template<class TDataType , class TIndexType >
std::istream & operator>> (std::istream &rIStream, DistributedVectorImporter< TDataType, TIndexType > &rThis)
 input stream function More...
 
template<class TDataType , class TIndexType >
std::ostream & operator<< (std::ostream &rOStream, const DistributedVectorImporter< TDataType, TIndexType > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, EdgeBasedDataStructure< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const EdgeBasedDataStructure< TDim > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Flags &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Flags &rThis)
 output stream function More...
 
template<class TGeometryType >
std::istream & operator>> (std::istream &rIStream, GeometryContainer< TGeometryType > &rThis)
 input stream function More...
 
template<class TGeometryType >
std::ostream & operator<< (std::ostream &rOStream, const GeometryContainer< TGeometryType > &rThis)
 output stream function More...
 
template<class TDataType , class TValueType >
std::istream & operator>> (std::istream &rIStream, GlobalPointersUnorderedMap< TDataType, TValueType > &rThis)
 input stream function More...
 
template<class TDataType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const GlobalPointersUnorderedMap< TDataType, TValueType > &rThis)
 output stream function More...
 
template<class TDataType >
std::istream & operator>> (std::istream &rIStream, GlobalPointersVector< TDataType > &rThis)
 input stream function More...
 
template<class TDataType >
std::ostream & operator<< (std::ostream &rOStream, const GlobalPointersVector< TDataType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Model &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Model &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, NodalData &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const NodalData &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, PeriodicVariablesContainer &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const PeriodicVariablesContainer &rThis)
 output stream function More...
 
template<class TDataType , class TGetKeyType , class TCompareType , class TEqualType , class TPointerType , class ContainerType >
std::ostream & operator<< (std::ostream &rOStream, const PointerHashMapSet< TDataType, TGetKeyType, TCompareType, TPointerType > &rThis)
 input stream function More...
 
template<class TDataType , class TPointerType , class TContainerType >
std::istream & operator>> (std::istream &rIStream, PointerVector< TDataType, TPointerType, TContainerType > &rThis)
 input stream function More...
 
template<class TDataType , class TPointerType , class TContainerType >
std::ostream & operator<< (std::ostream &rOStream, const PointerVector< TDataType, TPointerType, TContainerType > &rThis)
 output stream function More...
 
template<class TDataType , class TGetKeyType , class TCompareType , class TPointerType , class TContainerType >
std::istream & operator>> (std::istream &rIStream, PointerVectorMap< TDataType, TGetKeyType, TCompareType, TPointerType, TContainerType > &rThis)
 input stream function More...
 
template<class TDataType , class TGetKeyType , class TCompareType , class TPointerType , class TContainerType >
std::ostream & operator<< (std::ostream &rOStream, const PointerVectorMap< TDataType, TGetKeyType, TCompareType, TPointerType, TContainerType > &rThis)
 output stream function More...
 
template<class TDataType , class TGetKeyType , class TCompareType , class TEqualType , class TPointerType , class TContainerType >
std::istream & operator>> (std::istream &rIStream, PointerVectorSet< TDataType, TGetKeyType, TCompareType, TEqualType, TPointerType, TContainerType > &rThis)
 input stream function More...
 
template<class TDataType , class TGetKeyType , class TCompareType , class TEqualType , class TPointerType , class TContainerType >
std::ostream & operator<< (std::ostream &rOStream, const PointerVectorSet< TDataType, TGetKeyType, TCompareType, TEqualType, TPointerType, TContainerType > &rThis)
 output stream function More...
 
template<class TIndexType = std::size_t>
std::istream & operator>> (std::istream &rIStream, SparseContiguousRowGraph< TIndexType > &rThis)
 input stream function More...
 
template<class TIndexType = std::size_t>
std::ostream & operator<< (std::ostream &rOStream, const SparseContiguousRowGraph< TIndexType > &rThis)
 output stream function More...
 
template<class TIndexType = std::size_t>
std::istream & operator>> (std::istream &rIStream, SparseGraph< TIndexType > &rThis)
 input stream function More...
 
template<class TIndexType = std::size_t>
std::ostream & operator<< (std::ostream &rOStream, const SparseGraph< TIndexType > &rThis)
 output stream function More...
 
template<class TDataType , class TIndexType >
std::istream & operator>> (std::istream &rIStream, SystemVector< TDataType, TIndexType > &rThis)
 input stream function More...
 
template<class TDataType , class TIndexType >
std::ostream & operator<< (std::ostream &rOStream, const SystemVector< TDataType, TIndexType > &rThis)
 output stream function More...
 
template<class TDataType >
std::istream & operator>> (std::istream &rIStream, Variable< TDataType > &rThis)
 input stream function More...
 
template<class TDataType >
std::ostream & operator<< (std::ostream &rOStream, const Variable< TDataType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, VariableData &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const VariableData &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, VariablesList &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const VariablesList &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, VariablesListDataValueContainer &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const VariablesListDataValueContainer &rThis)
 output stream function More...
 
template<class TDataType , class TPointerType , class TContainerType >
std::istream & operator>> (std::istream &rIStream, WeakPointerVector< TDataType, TPointerType, TContainerType > &rThis)
 input stream function More...
 
template<class TDataType , class TPointerType , class TContainerType >
std::ostream & operator<< (std::ostream &rOStream, const WeakPointerVector< TDataType, TPointerType, TContainerType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Controller &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Controller &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, DistanceCalculationElementSimplex< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const DistanceCalculationElementSimplex< TDim > &rThis)
 output stream function More...
 
template<std::size_t TDim>
std::istream & operator>> (std::istream &rIStream, EdgeBasedGradientRecoveryElement< TDim > &rThis)
 input stream function More...
 
template<std::size_t TDim>
std::ostream & operator<< (std::ostream &rOStream, const EdgeBasedGradientRecoveryElement< TDim > &rThis)
 output stream function More...
 
template<class TVarType >
std::istream & operator>> (std::istream &rIStream, EmbeddedNodalVariableCalculationElementSimplex< TVarType > &rThis)
 input stream function More...
 
template<class TVarType >
std::ostream & operator<< (std::ostream &rOStream, const EmbeddedNodalVariableCalculationElementSimplex< TVarType > &rThis)
 output stream function More...
 
template<class TContainerType , MeshType TMeshType>
std::ostream & operator<< (std::ostream &rOStream, const ContainerExpression< TContainerType, TMeshType > &rThis)
 output stream function More...
 
template<class TClass >
std::ostream & operator<< (std::ostream &rOStream, const Factory< TClass > &rThis)
 output stream function More...
 
template<typename TSparseSpace , typename TLocalSpace >
std::ostream & operator<< (std::ostream &rOStream, const LinearSolverFactory< TSparseSpace, TLocalSpace > &rThis)
 output stream function More...
 
template<typename TSparseSpace , typename TLocalSpace >
std::ostream & operator<< (std::ostream &rOStream, const PreconditionerFactory< TSparseSpace, TLocalSpace > &rThis)
 output stream function More...
 
void RegisterLinearSolvers ()
 
template<typename TSparseSpace , typename TLocalSpace , typename TLinearSolverType >
std::ostream & operator<< (std::ostream &rOStream, const StandardLinearSolverFactory< TSparseSpace, TLocalSpace, TLinearSolverType > &rThis)
 output stream function More...
 
void RegisterPreconditioners ()
 
template<typename TSparseSpace , typename TLocalSpace , typename TPreconditionerType >
std::ostream & operator<< (std::ostream &rOStream, const StandardPreconditionerFactory< TSparseSpace, TLocalSpace, TPreconditionerType > &rThis)
 output stream function More...
 
template<typename TPointType >
std::istream & operator>> (std::istream &rIStream, BoundingBox< TPointType > &rThis)
 input stream function More...
 
template<typename TPointType >
std::ostream & operator<< (std::ostream &rOStream, const BoundingBox< TPointType > &rThis)
 output stream function More...
 
template<class TContainerPointType , class TContainerPointEmbeddedType = TContainerPointType>
std::istream & operator>> (std::istream &rIStream, BrepCurve< TContainerPointType, TContainerPointEmbeddedType > &rThis)
 input stream functions More...
 
template<class TContainerPointType , class TContainerPointEmbeddedType = TContainerPointType>
std::ostream & operator<< (std::ostream &rOStream, const BrepCurve< TContainerPointType, TContainerPointEmbeddedType > &rThis)
 output stream functions More...
 
template<class TContainerPointType , class TContainerPointEmbeddedType = TContainerPointType>
std::istream & operator>> (std::istream &rIStream, BrepCurveOnSurface< TContainerPointType, TContainerPointEmbeddedType > &rThis)
 input stream functions More...
 
template<class TContainerPointType , class TContainerPointEmbeddedType = TContainerPointType>
std::ostream & operator<< (std::ostream &rOStream, const BrepCurveOnSurface< TContainerPointType, TContainerPointEmbeddedType > &rThis)
 output stream functions More...
 
template<class TContainerPointType , class TContainerPointEmbeddedType = TContainerPointType>
std::istream & operator>> (std::istream &rIStream, BrepSurface< TContainerPointType, TContainerPointEmbeddedType > &rThis)
 input stream functions More...
 
template<class TContainerPointType , class TContainerPointEmbeddedType = TContainerPointType>
std::ostream & operator<< (std::ostream &rOStream, const BrepSurface< TContainerPointType, TContainerPointEmbeddedType > &rThis)
 output stream functions More...
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, CouplingGeometry< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const CouplingGeometry< TPointType > &rThis)
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Geometry< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Geometry< TPointType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, GeometryData &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const GeometryData &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, GeometryDimension &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const GeometryDimension &rThis)
 output stream function More...
 
template<typename TIntegrationMethodType >
std::istream & operator>> (std::istream &rIStream, GeometryShapeFunctionContainer< TIntegrationMethodType > &rThis)
 input stream function More...
 
template<typename TIntegrationMethodType >
std::ostream & operator<< (std::ostream &rOStream, const GeometryShapeFunctionContainer< TIntegrationMethodType > &rThis)
 output stream function More...
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Line2D2< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Line2D2< TPointType > &rThis)
 output stream function More...
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Line2D3< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Line2D3< TPointType > &rThis)
 output stream function More...
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Line2D4< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Line2D4< TPointType > &rThis)
 output stream function More...
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Line2D5< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Line2D5< TPointType > &rThis)
 output stream function More...
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Line3D2< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Line3D2< TPointType > &rThis)
 output stream function More...
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Line3D3< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Line3D3< TPointType > &rThis)
 output stream function More...
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, LineGaussLobatto3D2< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const LineGaussLobatto3D2< TPointType > &rThis)
 output stream function More...
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, NurbsVolumeGeometry< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const NurbsVolumeGeometry< TPointType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Plane3D &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Plane3D &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Point &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Point &rThis)
 output stream function More...
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Point2D< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Point2D< TPointType > &rThis)
 output stream function More...
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Point3D< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Point3D< TPointType > &rThis)
 output stream function More...
 
template<class TContainerPointType , int TWorkingSpaceDimension, int TLocalSpaceDimensionOfBackground>
std::istream & operator>> (std::istream &rIStream, PointOnGeometry< TContainerPointType, TWorkingSpaceDimension, TLocalSpaceDimensionOfBackground > &rThis)
 input stream functions More...
 
template<class TContainerPointType , int TWorkingSpaceDimension, int TLocalSpaceDimensionOfBackground>
std::ostream & operator<< (std::ostream &rOStream, const PointOnGeometry< TContainerPointType, TWorkingSpaceDimension, TLocalSpaceDimensionOfBackground > &rThis)
 output stream functions More...
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, PrismInterface3D6< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const PrismInterface3D6< TPointType > &rThis)
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Pyramid3D13< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Pyramid3D13< TPointType > &rThis)
 output stream function More...
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Pyramid3D5< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Pyramid3D5< TPointType > &rThis)
 output stream function More...
 
template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension, int TDimension>
std::istream & operator>> (std::istream &rIStream, QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension > &rThis)
 input stream function More...
 
template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension, int TDimension>
std::ostream & operator<< (std::ostream &rOStream, const QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension > &rThis)
 output stream function More...
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Quadrilateral2D4< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Quadrilateral2D4< TPointType > &rThis)
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Quadrilateral3D4< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Quadrilateral3D4< TPointType > &rThis)
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, QuadrilateralInterface2D4< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const QuadrilateralInterface2D4< TPointType > &rThis)
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, QuadrilateralInterface3D4< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const QuadrilateralInterface3D4< TPointType > &rThis)
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Sphere3D1< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Sphere3D1< TPointType > &rThis)
 output stream function More...
 
template<class TPointType >
const GeometryData Sphere3D1< TPointType >::msGeometryData & msGeometryDimension (), Sphere3D1< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Tetrahedra3D10< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Tetrahedra3D10< TPointType > &rThis)
 output stream function More...
 
template<class TPointType >
const GeometryData Tetrahedra3D10< TPointType >::msGeometryData & msGeometryDimension (), Tetrahedra3D10< TPointType >::AllShapeFunctionsValues(), AllShapeFunctionsLocalGradients()
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Triangle2D10< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Triangle2D10< TPointType > &rThis)
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Triangle2D15< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Triangle2D15< TPointType > &rThis)
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Triangle2D3< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Triangle2D3< TPointType > &rThis)
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Triangle2D6< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Triangle2D6< TPointType > &rThis)
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Triangle3D3< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Triangle3D3< TPointType > &rThis)
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Triangle3D6< TPointType > &rThis)
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Triangle3D6< TPointType > &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const CodeLocation &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Communicator &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Communicator &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Condition &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Condition &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ConstitutiveLaw &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ConstitutiveLaw &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ConvectionDiffusionSettings &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ConvectionDiffusionSettings &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DataCommunicator &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DataCommunicator &rThis)
 output stream function More...
 
template<class TDataType >
std::istream & operator>> (std::istream &rIStream, Dof< TDataType > &rThis)
 input stream function More...
 
template<class TDataType >
std::ostream & operator<< (std::ostream &rOStream, const Dof< TDataType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Element &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Element &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Exception &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Exception &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, FillCommunicator &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FillCommunicator &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FixedSizeMemoryPool &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, GeometricalObject &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const GeometricalObject &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const GidIO<> &rThis)
 
std::istream & operator>> (std::istream &rIStream, IndexedObject &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const IndexedObject &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, IO &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const IO &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Kernel &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Kernel &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, KratosApplication &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const KratosApplication &rThis)
 output stream function More...
 
template<class TComponentType >
std::ostream & operator<< (std::ostream &rOStream, const KratosComponents< TComponentType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Parameters &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Parameters &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MemoryInfo &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MemoryInfo &rThis)
 output stream function More...
 
template<class TNodeType , class TPropertiesType , class TElementType , class TConditionType >
std::istream & operator>> (std::istream &rIStream, Mesh< TNodeType, TPropertiesType, TElementType, TConditionType > &rThis)
 input stream function More...
 
template<class TNodeType , class TPropertiesType , class TElementType , class TConditionType >
std::ostream & operator<< (std::ostream &rOStream, const Mesh< TNodeType, TPropertiesType, TElementType, TConditionType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ModelPart &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ModelPart &rThis)
 output stream function More...
 
template<class TNodeType , class TElementType >
std::istream & operator>> (std::istream &rIStream, Neighbours< TNodeType, TElementType > &rThis)
 input stream function More...
 
template<class TNodeType , class TElementType >
std::ostream & operator<< (std::ostream &rOStream, const Neighbours< TNodeType, TElementType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Node &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Node &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, PeriodicCondition &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const PeriodicCondition &rThis)
 output stream function More...
 
template<class TArgumentType , class TResultType >
std::istream & operator>> (std::istream &rIStream, Table< TArgumentType, TResultType > &rThis)
 input stream function More...
 
template<class TArgumentType , class TResultType >
std::ostream & operator<< (std::ostream &rOStream, const Table< TArgumentType, TResultType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, PoolObject &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const PoolObject &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ProcessInfo &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ProcessInfo &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Properties &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Properties &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RadiationSettings &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RadiationSettings &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Registry &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Registry &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RegistryItem &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RegistryItem &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ThreadFixedSizeMemoryPool &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Logger &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Logger &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const LoggerMessage &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const LoggerOutput &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const LoggerTableOutput &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, StlIO &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const StlIO &rThis)
 output stream function More...
 
template<std::size_t TDimension, class TDataType , class TWeightType >
std::istream & operator>> (std::istream &rIStream, IntegrationInfo &rThis)
 input stream function More...
 
template<std::size_t TDimension, class TDataType , class TWeightType >
std::ostream & operator<< (std::ostream &rOStream, const IntegrationInfo &rThis)
 output stream function More...
 
template<std::size_t TDimension, class TDataType , class TWeightType >
std::istream & operator>> (std::istream &rIStream, IntegrationPoint< TDimension, TDataType, TWeightType > &rThis)
 input stream function More...
 
template<std::size_t TDimension, class TDataType , class TWeightType >
std::ostream & operator<< (std::ostream &rOStream, const IntegrationPoint< TDimension, TDataType, TWeightType > &rThis)
 output stream function More...
 
template<class TQuadraturePointsType , std::size_t TDimension, class TIntegrationPointType >
std::istream & operator>> (std::istream &rIStream, Quadrature< TQuadraturePointsType, TDimension, TIntegrationPointType > &rThis)
 input stream function More...
 
template<class TQuadraturePointsType , std::size_t TDimension, class TIntegrationPointType >
std::ostream & operator<< (std::ostream &rOStream, const Quadrature< TQuadraturePointsType, TDimension, TIntegrationPointType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::istream & operator>> (std::istream &IStream, BICGSTABSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::ostream & operator<< (std::ostream &OStream, const BICGSTABSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::istream & operator>> (std::istream &IStream, CGSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::ostream & operator<< (std::ostream &OStream, const CGSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::istream & operator>> (std::istream &IStream, DeflatedCGSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::ostream & operator<< (std::ostream &OStream, const DeflatedCGSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType >
std::istream & operator>> (std::istream &IStream, DiagonalPreconditioner< TSparseSpaceType, TDenseSpaceType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType >
std::ostream & operator<< (std::ostream &OStream, const DiagonalPreconditioner< TSparseSpaceType, TDenseSpaceType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType >
std::istream & operator>> (std::istream &IStream, ILU0Preconditioner< TSparseSpaceType, TDenseSpaceType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType >
std::ostream & operator<< (std::ostream &OStream, const ILU0Preconditioner< TSparseSpaceType, TDenseSpaceType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType >
std::istream & operator>> (std::istream &IStream, ILUPreconditioner< TSparseSpaceType, TDenseSpaceType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType >
std::ostream & operator<< (std::ostream &OStream, const ILUPreconditioner< TSparseSpaceType, TDenseSpaceType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::istream & operator>> (std::istream &IStream, IterativeSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::ostream & operator<< (std::ostream &OStream, const IterativeSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream & operator>> (std::istream &IStream, LinearSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream & operator<< (std::ostream &rOStream, const LinearSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::istream & operator>> (std::istream &IStream, MonotonicityPreservingSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::ostream & operator<< (std::ostream &OStream, const MonotonicityPreservingSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::istream & operator>> (std::istream &IStream, PowerIterationEigenvalueSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::ostream & operator<< (std::ostream &OStream, const PowerIterationEigenvalueSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::istream & operator>> (std::istream &IStream, PowerIterationHighestEigenvalueSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::ostream & operator<< (std::ostream &OStream, const PowerIterationHighestEigenvalueSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType >
std::istream & operator>> (std::istream &IStream, Preconditioner< TSparseSpaceType, TDenseSpaceType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType >
std::ostream & operator<< (std::ostream &OStream, const Preconditioner< TSparseSpaceType, TDenseSpaceType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::istream & operator>> (std::istream &IStream, RayleighQuotientIterationEigenvalueSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::ostream & operator<< (std::ostream &OStream, const RayleighQuotientIterationEigenvalueSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType >
std::istream & operator>> (std::istream &rIStream, Reorderer< TSparseSpaceType, TDenseSpaceType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType >
std::ostream & operator<< (std::ostream &rOStream, const Reorderer< TSparseSpaceType, TDenseSpaceType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::istream & operator>> (std::istream &IStream, ScalingSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::ostream & operator<< (std::ostream &OStream, const ScalingSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream & operator>> (std::istream &rIStream, SkylineLUCustomScalarSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream & operator<< (std::ostream &rOStream, const SkylineLUCustomScalarSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CadIoModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CadIoModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CartesianMeshGeneratorModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CartesianMeshGeneratorModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CombineModelPartModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CombineModelPartModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CopyPropertiesModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CopyPropertiesModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CreateEntitiesFromGeometriesModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CreateEntitiesFromGeometriesModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DuplicateMeshModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DuplicateMeshModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, EdgeSwapping2DModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const EdgeSwapping2DModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MeshSuiteModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MeshSuiteModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Modeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Modeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SerialModelPartCombinatorModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SerialModelPartCombinatorModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, StructuredMeshRefinementModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const StructuredMeshRefinementModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TetrahedraBall &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TetrahedraBall &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TetrahedraEdgeShell &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TetrahedraEdgeShell &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MPICommunicator &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MPICommunicator &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MPIDataCommunicator &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MPIDataCommunicator &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, GatherModelPartUtility &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const GatherModelPartUtility &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MPINormalCalculationUtils &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MPINormalCalculationUtils &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ParallelFillCommunicator &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ParallelFillCommunicator &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Operation &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Operation &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ApplyConstantScalarValueProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyConstantScalarValueProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ApplyConstantVectorValueProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyConstantVectorValueProcess &rThis)
 output stream function More...
 
template<std::size_t TDim>
std::istream & operator>> (std::istream &rIStream, ApplyRayCastingInterfaceRecognitionProcess< TDim > &rThis)
 input stream function More...
 
template<std::size_t TDim>
std::ostream & operator<< (std::ostream &rOStream, const ApplyRayCastingInterfaceRecognitionProcess< TDim > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ApplyRayCastingProcess<> &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyRayCastingProcess<> &rThis)
 output stream function More...
 
template<class TEntity >
std::istream & operator>> (std::istream &rIStream, AssignScalarFieldToEntitiesProcess< TEntity > &rThis)
 input stream function More...
 
template<class TEntity >
std::ostream & operator<< (std::ostream &rOStream, const AssignScalarFieldToEntitiesProcess< TEntity > &rThis)
 output stream function More...
 
template<class TEntity >
std::istream & operator>> (std::istream &rIStream, AssignScalarInputToEntitiesProcess< TEntity > &rThis)
 input stream function More...
 
template<class TEntity >
std::ostream & operator<< (std::ostream &rOStream, const AssignScalarInputToEntitiesProcess< TEntity > &rThis)
 output stream function More...
 
template<class TEntity >
std::istream & operator>> (std::istream &rIStream, AssignScalarVariableToEntitiesProcess< TEntity > &rThis)
 input stream function More...
 
template<class TEntity >
std::ostream & operator<< (std::ostream &rOStream, const AssignScalarVariableToEntitiesProcess< TEntity > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CalculateDiscontinuousDistanceToSkinProcess<> &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CalculateDiscontinuousDistanceToSkinProcess<> &rThis)
 output stream function More...
 
template<bool THistorical>
std::istream & operator>> (std::istream &rIStream, CalculateDistanceToPathProcess< THistorical > &rThis)
 input stream function More...
 
template<bool THistorical>
std::ostream & operator<< (std::ostream &rOStream, const CalculateDistanceToPathProcess< THistorical > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CalculateDistanceToSkinProcess<> &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CalculateDistanceToSkinProcess<> &rThis)
 output stream function More...
 
template<class TVarType , class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::istream & operator>> (std::istream &rIStream, CalculateEmbeddedNodalVariableFromSkinProcess< TVarType, TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 input stream function More...
 
template<class TVarType , class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::ostream & operator<< (std::ostream &rOStream, const CalculateEmbeddedNodalVariableFromSkinProcess< TVarType, TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CalculateEmbeddedSignedDistanceTo3DSkinProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CalculateEmbeddedSignedDistanceTo3DSkinProcess &rThis)
 output stream function More...
 
template<bool THistorical = true>
std::istream & operator>> (std::istream &rIStream, CalculateNodalAreaProcess< THistorical > &rThis)
 input stream function More...
 
template<bool THistorical = true>
std::ostream & operator<< (std::ostream &rOStream, const CalculateNodalAreaProcess< THistorical > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CalculateSignedDistanceTo3DConditionSkinProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CalculateSignedDistanceTo3DConditionSkinProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CalculateSignedDistanceTo3DSkinProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CalculateSignedDistanceTo3DSkinProcess &rThis)
 output stream function More...
 
template<std::size_t TDim>
std::istream & operator>> (std::istream &rIStream, CheckSameModelPartUsingSkinDistanceProcess< TDim > &rThis)
 input stream function More...
 
template<std::size_t TDim>
std::ostream & operator<< (std::ostream &rOStream, const CheckSameModelPartUsingSkinDistanceProcess< TDim > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CheckSkinProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CheckSkinProcess &rThis)
 output stream function More...
 
template<class TSystemSpaceType , class TDirichletSpaceType >
std::istream & operator>> (std::istream &rIStream, ConstructSystemMatrixElementalProcess< TSystemSpaceType, TDirichletSpaceType > &rThis)
 input stream function More...
 
template<class TSystemSpaceType , class TDirichletSpaceType >
std::ostream & operator<< (std::ostream &rOStream, const ConstructSystemMatrixElementalProcess< TSystemSpaceType, TDirichletSpaceType > &rThis)
 output stream function More...
 
template<class TDataType , class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::istream & operator>> (std::istream &rIStream, EdgeBasedGradientRecoveryProcess< TDataType, TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 Input stream function. More...
 
template<class TDataType , class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::ostream & operator<< (std::ostream &rOStream, const EdgeBasedGradientRecoveryProcess< TDataType, TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 Output stream function. More...
 
std::istream & operator>> (std::istream &rIStream, EliminateIsolatedNodesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const EliminateIsolatedNodesProcess &rThis)
 output stream function More...
 
template<class TEntity >
std::istream & operator>> (std::istream &rIStream, EntitiesEraseProcess< TEntity > &rThis)
 input stream function More...
 
template<class TEntity >
std::ostream & operator<< (std::ostream &rOStream, const EntitiesEraseProcess< TEntity > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, FastTransferBetweenModelPartsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FastTransferBetweenModelPartsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, FindConditionsNeighboursProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FindConditionsNeighboursProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, FindGlobalNodalElementalNeighboursProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FindGlobalNodalElementalNeighboursProcess &rThis)
 output stream function More...
 
template<class TContainerType >
std::istream & operator>> (std::istream &rIStream, FindGlobalNodalEntityNeighboursProcess< TContainerType > &rThis)
 input stream function More...
 
template<class TContainerType >
std::ostream & operator<< (std::ostream &rOStream, const FindGlobalNodalEntityNeighboursProcess< TContainerType > &rThis)
 output stream function More...
 
template<class TContainerType >
std::istream & operator>> (std::istream &rIStream, FindNodalNeighboursForEntitiesProcess< TContainerType > &rThis)
 input stream function More...
 
template<class TContainerType >
std::ostream & operator<< (std::ostream &rOStream, const FindNodalNeighboursForEntitiesProcess< TContainerType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, FindGlobalNodalNeighboursProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FindGlobalNodalNeighboursProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, FindIntersectedGeometricalObjectsWithOBBProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FindIntersectedGeometricalObjectsWithOBBProcess &rThis)
 output stream function More...
 
template<bool THistorical>
std::istream & operator>> (std::istream &rIStream, FindNodalHProcess< THistorical > &rThis)
 input stream function More...
 
template<bool THistorical>
std::ostream & operator<< (std::ostream &rOStream, const FindNodalHProcess< THistorical > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, FindNodalNeighboursProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FindNodalNeighboursProcess &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, FluxCorrectedTransportConvectionProcess< TDim > &rThis)
 Input stream function. More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const FluxCorrectedTransportConvectionProcess< TDim > &rThis)
 Output stream function. More...
 
std::istream & operator>> (std::istream &rIStream, FromJSONCheckResultProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FromJSONCheckResultProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, GenericFindElementalNeighboursProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const GenericFindElementalNeighboursProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, GraphColoringProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const GraphColoringProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, IntegrationValuesExtrapolationToNodesProcess &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const IntegrationValuesExtrapolationToNodesProcess &rThis)
 
template<unsigned int TDim, class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::istream & operator>> (std::istream &rIStream, LevelSetConvectionProcess< TDim, TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 Input stream function. More...
 
template<unsigned int TDim, class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::ostream & operator<< (std::ostream &rOStream, const LevelSetConvectionProcess< TDim, TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 Output stream function. More...
 
std::istream & operator>> (std::istream &rIStream, MeasureMeshQualityProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MeasureMeshQualityProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MeshCoarseningProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MeshCoarseningProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MeshLocalSmoothingProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MeshLocalSmoothingProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MeshNodeCollapsingProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MeshNodeCollapsingProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const OutputProcess &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, ParallelDistanceCalculationProcess< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const ParallelDistanceCalculationProcess< TDim > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Process &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Process &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ReorderAndOptimizeModelPartProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ReorderAndOptimizeModelPartProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ReplaceElementsAndConditionsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ReplaceElementsAndConditionsProcess &rThis)
 output stream function More...
 
template<SizeType TDim>
std::istream & operator>> (std::istream &rIStream, SkinDetectionProcess< TDim > &rThis)
 input stream function More...
 
template<SizeType TDim>
std::ostream & operator<< (std::ostream &rOStream, const SkinDetectionProcess< TDim > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SplitInternalInterfacesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SplitInternalInterfacesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, StructuredMeshGeneratorProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const StructuredMeshGeneratorProcess &rThis)
 output stream function More...
 
template<SizeType TDim>
std::istream & operator>> (std::istream &rIStream, SubModelPartSkinDetectionProcess< TDim > &rThis)
 input stream function More...
 
template<SizeType TDim>
std::ostream & operator<< (std::ostream &rOStream, const SubModelPartSkinDetectionProcess< TDim > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TetrahedraMeshEdgeSwappingProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TetrahedraMeshEdgeSwappingProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TetrahedraMeshQualityWeightedSmoothingProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TetrahedraMeshQualityWeightedSmoothingProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TetrahedraMeshWorstElementSmoothingProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TetrahedraMeshWorstElementSmoothingProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TetrahedralMeshOrientationCheck &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TetrahedralMeshOrientationCheck &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TimeAveragingProcess &rThis)
 output stream function More...
 
template<unsigned int TDim, class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::istream & operator>> (std::istream &rIStream, VariationalDistanceCalculationProcess< TDim, TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 input stream function More...
 
template<unsigned int TDim, class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::ostream & operator<< (std::ostream &rOStream, const VariationalDistanceCalculationProcess< TDim, TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 output stream function More...
 
template<std::size_t TDimension, class TPointType , class TContainerType , class TPointerType , class TIteratorType , class TDistanceIteratorType , class TDistanceFunction >
std::ostream & operator<< (std::ostream &rOStream, BinsDynamic< TDimension, TPointType, TContainerType, TPointerType, TIteratorType, TDistanceIteratorType, TDistanceFunction > &rThis)
 output stream function More...
 
template<class TConfigure >
std::istream & operator>> (std::istream &rIStream, BinsObjectDynamic< TConfigure > &rThis)
 input stream function More...
 
template<class TConfigure >
std::ostream & operator<< (std::ostream &rOStream, const BinsObjectDynamic< TConfigure > &rThis)
 output stream function More...
 
template<class TConfigure >
std::istream & operator>> (std::istream &rIStream, BinsObjectStatic< TConfigure > &rThis)
 input stream function More...
 
template<class TConfigure >
std::ostream & operator<< (std::ostream &rOStream, const BinsObjectStatic< TConfigure > &rThis)
 output stream function More...
 
template<std::size_t TDimension, class TPointType , class TContainerType , class TPointerType , class TIteratorType , class TDistanceIteratorType , class TDistanceFunction >
std::istream & operator>> (std::istream &rIStream, Bucket< TDimension, TPointType, TContainerType, TPointerType, TIteratorType, TDistanceIteratorType, TDistanceFunction > &rThis)
 input stream function More...
 
template<std::size_t TDimension, class TPointType , class TContainerType , class TPointerType , class TIteratorType , class TDistanceIteratorType , class TDistanceFunction >
std::ostream & operator<< (std::ostream &rOStream, const Bucket< TDimension, TPointType, TContainerType, TPointerType, TIteratorType, TDistanceIteratorType, TDistanceFunction > &rThis)
 output stream function More...
 
template<class TConfigure >
std::istream & operator>> (std::istream &rIStream, Cell< TConfigure > &rThis)
 input stream function More...
 
template<class TConfigure >
std::ostream & operator<< (std::ostream &rOStream, const Cell< TConfigure > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, NodeConfigure &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const NodeConfigure &rThis)
 output stream function More...
 
template<class TCellType >
std::ostream & operator<< (std::ostream &rOStream, const OctreeBinary< TCellType > &rThis)
 input stream function More...
 
template<class TConfiguration >
std::ostream & operator<< (std::ostream &rOStream, const OctreeBinaryCell< TConfiguration > &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SpatialSearch &rThis)
 output stream function More...
 
template<typename TObjectType >
std::istream & operator>> (std::istream &rIStream, SpatialSearchResult< TObjectType > &rThis)
 input stream function More...
 
template<typename TObjectType >
std::ostream & operator<< (std::ostream &rOStream, const SpatialSearchResult< TObjectType > &rThis)
 output stream function More...
 
template<SpatialContainer TSearchBackend>
std::ostream & operator<< (std::ostream &rOStream, const SpecializedSpatialSearch< TSearchBackend > &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SpecializedSpatialSearchFactory &rThis)
 output stream function More...
 
template<class TPartitionType >
std::istream & operator>> (std::istream &rIStream, Tree< TPartitionType > &rThis)
 input stream function More...
 
template<class TPartitionType >
std::ostream & operator<< (std::ostream &rOStream, const Tree< TPartitionType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TestSkippedException &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TestSkippedException &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AssignUniqueModelPartCollectionTagUtility &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AssignUniqueModelPartCollectionTagUtility &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const BruteForcePointLocator &rThis)
 output stream function More...
 
template<class TDataType >
std::istream & operator>> (std::istream &rIStream, MPIColoringUtilities &rThis)
 input stream function More...
 
template<class TDataType >
std::ostream & operator<< (std::ostream &rOStream, const MPIColoringUtilities &rThis)
 output stream function More...
 
template<class TContainerType , class TVariableType >
std::istream & operator>> (std::istream &rIStream, ComputeNeighbourListFunctor< TContainerType, TVariableType > &rThis)
 input stream function More...
 
template<class TContainerType , class TVariableType >
std::ostream & operator<< (std::ostream &rOStream, const ComputeNeighbourListFunctor< TContainerType, TVariableType > &rThis)
 output stream function More...
 
template<class TLocalMatrixType , class TLocalVectorType , class TValueType >
std::istream & operator>> (std::istream &rIStream, CoordinateTransformationUtils< TLocalMatrixType, TLocalVectorType, TValueType > &rThis)
 input stream function More...
 
template<class TLocalMatrixType , class TLocalVectorType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const CoordinateTransformationUtils< TLocalMatrixType, TLocalVectorType, TValueType > &rThis)
 output stream function More...
 
template<class TCountedType >
std::istream & operator>> (std::istream &rIStream, Counter< TCountedType > &rThis)
 input stream function More...
 
template<class TCountedType >
std::ostream & operator<< (std::ostream &rOStream, const Counter< TCountedType > &rThis)
 output stream function More...
 
template<class TSparseSpace >
std::istream & operator>> (std::istream &rIStream, DofUpdater< TSparseSpace > &rThis)
 input stream function More...
 
template<class TSparseSpace >
std::ostream & operator<< (std::ostream &rOStream, const DofUpdater< TSparseSpace > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, GeometryTesterUtility &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const GeometryTesterUtility &rThis)
 output stream function More...
 
template<class TContainerType >
std::istream & operator>> (std::istream &rIStream, GetValueFunctor< TContainerType > &rThis)
 input stream function More...
 
template<class TContainerType >
std::ostream & operator<< (std::ostream &rOStream, const GetValueFunctor< TContainerType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, GlobalPointerUtilities &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const GlobalPointerUtilities &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MergeVariableListsUtility &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MergeVariableListsUtility &rThis)
 output stream function More...
 
template<class TCountedType >
std::istream & operator>> (std::istream &rIStream, ObjectCounter< TCountedType > &rThis)
 input stream function More...
 
template<class TCountedType >
std::ostream & operator<< (std::ostream &rOStream, const ObjectCounter< TCountedType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ParticlesUtilities &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ParticlesUtilities &rThis)
 output stream function More...
 
template<class TPointerDataType , class TSendType >
std::istream & operator>> (std::istream &rIStream, GlobalPointerCommunicator< TPointerDataType > &rThis)
 input stream function More...
 
template<class TPointerDataType , class TSendType >
std::ostream & operator<< (std::ostream &rOStream, const GlobalPointerCommunicator< TPointerDataType > &rThis)
 output stream function More...
 
template<class TPointerDataType , class TDataType >
std::istream & operator>> (std::istream &rIStream, GlobalPointerMapCommunicator< TPointerDataType, TDataType > &rThis)
 input stream function More...
 
template<class TPointerDataType , class TDataType >
std::ostream & operator<< (std::ostream &rOStream, const GlobalPointerMapCommunicator< TPointerDataType, TDataType > &rThis)
 output stream function More...
 
template<class TContainerType >
std::istream & operator>> (std::istream &rIStream, RetrieveGlobalPointersByIndex< TContainerType > &rThis)
 input stream function More...
 
template<class TContainerType >
std::ostream & operator<< (std::ostream &rOStream, const RetrieveGlobalPointersByIndex< TContainerType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RVEPeriodicityUtility &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RVEPeriodicityUtility &rThis)
 output stream function More...
 
template<std::size_t TDimension>
std::istream & operator>> (std::istream &rIStream, SpatialContainersConfigure< TDimension > &rThis)
 input stream function More...
 
template<std::size_t TDimension>
std::ostream & operator<< (std::ostream &rOStream, const SpatialContainersConfigure< TDimension > &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Timer &rThis)
 input stream function More...
 
template<class TPointType >
std::istream & operator>> (std::istream &rIStream, Line3DN< TPointType > &rThis)
 input stream function More...
 
template<class TPointType >
std::ostream & operator<< (std::ostream &rOStream, const Line3DN< TPointType > &rThis)
 output stream function More...
 
template<class TDenseSpace , class TSparseSpace , class TLinearSolver >
std::istream & operator>> (std::istream &rIStream, FractionalStepSettingsForChimera< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 input stream function More...
 
template<class TDenseSpace , class TSparseSpace , class TLinearSolver >
std::ostream & operator<< (std::ostream &rOStream, const FractionalStepSettingsForChimera< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, PotentialWallCondition< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const PotentialWallCondition< TDim, TNumNodes > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ApplyFarFieldProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyFarFieldProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Define2DWakeProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Define2DWakeProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Define3DWakeProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Define3DWakeProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, KuttaConditionProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const KuttaConditionProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ConstitutiveModelData &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ConstitutiveModelData &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, PropertiesLayout &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const PropertiesLayout &rThis)
 output stream function More...
 
template<class TArgumentType , class TResultType >
std::istream & operator>> (std::istream &rIStream, TableKeyVariables< TArgumentType, TResultType > &rThis)
 input stream function More...
 
template<class TArgumentType , class TResultType >
std::ostream & operator<< (std::ostream &rOStream, const TableKeyVariables< TArgumentType, TResultType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CoulombAdhesionFrictionLaw &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const CoulombAdhesionFrictionLaw &rThis)
 
std::istream & operator>> (std::istream &rIStream, FrictionLaw &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FrictionLaw &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, HardeningCoulombFrictionLaw &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const HardeningCoulombFrictionLaw &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ContactDomain2DMesher &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ContactDomain2DMesher &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ContactDomain3DMesher &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ContactDomain3DMesher &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, BuildContactModelPartProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const BuildContactModelPartProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ClearContactConditionsMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ClearContactConditionsMesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ClearPointContactConditionsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ClearPointContactConditionsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, GenerateNewContactConditionsMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const GenerateNewContactConditionsMesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, HMParametricWallContactSearchProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const HMParametricWallContactSearchProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ParametricWallContactSearchProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ParametricWallContactSearchProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SettleContactModelStructureProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SettleContactModelStructureProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ContactDomainUtilities &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ContactDomainUtilities &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RigidBodyElementCreationUtility &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RigidBodyElementCreationUtility &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::istream & operator>> (std::istream &IStream, MixedULMLinearSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::ostream & operator<< (std::ostream &rOStream, const MixedULMLinearSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &rThis)
 output stream function More...
 
template<SizeType TDim, SizeType TNumNodes, SizeType TNumNodesMaster = TNumNodes>
std::istream & operator>> (std::istream &rIStream, AdvancedContactSearchProcess< TDim, TNumNodes, TNumNodesMaster > &rThis)
 
template<SizeType TDim, SizeType TNumNodes, SizeType TNumNodesMaster = TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const AdvancedContactSearchProcess< TDim, TNumNodes, TNumNodesMaster > &rThis)
 
std::istream & operator>> (std::istream &rIStream, ALMFastInit &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ALMFastInit &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ALMVariablesCalculationProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ALMVariablesCalculationProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AssignParentElementConditionsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AssignParentElementConditionsProcess &rThis)
 output stream function More...
 
template<SizeType TDim, SizeType TNumNodes, SizeType TNumNodesMaster>
std::istream & operator>> (std::istream &rIStream, BaseContactSearchProcess< TDim, TNumNodes, TNumNodesMaster > &rThis)
 
template<SizeType TDim, SizeType TNumNodes, SizeType TNumNodesMaster>
std::ostream & operator<< (std::ostream &rOStream, const BaseContactSearchProcess< TDim, TNumNodes, TNumNodesMaster > &rThis)
 
std::istream & operator>> (std::istream &rIStream, ComputeDynamicFactorProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ComputeDynamicFactorProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ContactSearchWrapperProcess &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const ContactSearchWrapperProcess &rThis)
 
std::istream & operator>> (std::istream &rIStream, FindIntersectedGeometricalObjectsWithOBBContactSearchProcess &rThis)
 input stream function More...
 
template<SizeType TDim, SizeType TNumNodes, SizeType TNumNodesMaster>
std::istream & operator>> (std::istream &rIStream, MPCContactSearchProcess< TDim, TNumNodes, TNumNodesMaster > &rThis)
 
template<SizeType TDim, SizeType TNumNodes, SizeType TNumNodesMaster>
std::ostream & operator<< (std::ostream &rOStream, const MPCContactSearchProcess< TDim, TNumNodes, TNumNodesMaster > &rThis)
 
std::istream & operator>> (std::istream &rIStream, MPCContactSearchWrapperProcess &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const MPCContactSearchWrapperProcess &rThis)
 
std::istream & operator>> (std::istream &rIStream, NormalCheckProcess &rThis)
 
std::ostream & operator<< (std::ostream &rOStream, const NormalCheckProcess &rThis)
 
template<SizeType TDim, SizeType TNumNodes, SizeType TNumNodesMaster>
std::istream & operator>> (std::istream &rIStream, NormalGapProcess< TDim, TNumNodes, TNumNodesMaster > &rThis)
 
template<SizeType TDim, SizeType TNumNodes, SizeType TNumNodesMaster>
std::ostream & operator<< (std::ostream &rOStream, const NormalGapProcess< TDim, TNumNodes, TNumNodesMaster > &rThis)
 
template<SizeType TDim, SizeType TNumNodes, SizeType TNumNodesMaster = TNumNodes>
std::istream & operator>> (std::istream &rIStream, SimpleContactSearchProcess< TDim, TNumNodes, TNumNodesMaster > &rThis)
 
template<SizeType TDim, SizeType TNumNodes, SizeType TNumNodesMaster = TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const SimpleContactSearchProcess< TDim, TNumNodes, TNumNodesMaster > &rThis)
 
std::istream & operator>> (std::istream &rIStream, ProcessFactoryUtility &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ProcessFactoryUtility &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AdjointThermalFace &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AdjointThermalFace &rThis)
 output stream function More...
 
template<class PrimalElement >
std::istream & operator>> (std::istream &rIStream, AdjointDiffusionElement< PrimalElement > &rThis)
 input stream function More...
 
template<class PrimalElement >
std::ostream & operator<< (std::ostream &rOStream, const AdjointDiffusionElement< PrimalElement > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes = TDim + 1>
std::istream & operator>> (std::istream &rIStream, DConvectionDiffusionExplicit< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes = TDim + 1>
std::ostream & operator<< (std::ostream &rOStream, const DConvectionDiffusionExplicit< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes = TDim + 1>
std::istream & operator>> (std::istream &rIStream, QSConvectionDiffusionExplicit< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes = TDim + 1>
std::ostream & operator<< (std::ostream &rOStream, const QSConvectionDiffusionExplicit< TDim, TNumNodes > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, LaplacianSmoothing &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const LaplacianSmoothing &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Mesher &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Mesher &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TetrahedralMesh3DMesher &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TetrahedralMesh3DMesher &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TriangularMesh2DMesher &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TriangularMesh2DMesher &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, BuildModelPartBoundaryProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const BuildModelPartBoundaryProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ElementalNeighboursSearchProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ElementalNeighboursSearchProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, GenerateNewConditionsMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const GenerateNewConditionsMesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, GenerateNewElementsMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const GenerateNewElementsMesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, GenerateNewNodesMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const GenerateNewNodesMesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ModelVolumeCalculationProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ModelVolumeCalculationProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, NodalNeighboursSearchProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const NodalNeighboursSearchProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, PrintMeshOutputMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const PrintMeshOutputMesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RefineConditionsMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RefineConditionsMesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RefineElementsInEdgesMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RefineElementsInEdgesMesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RefineElementsOnSizeMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RefineElementsOnSizeMesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RefineElementsOnThresholdMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RefineElementsOnThresholdMesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RemoveNodesMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RemoveNodesMesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SelectElementsMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SelectElementsMesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SettleModelStructureProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SettleModelStructureProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TransferBetweenModelPartsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TransferBetweenModelPartsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MeshDataTransferUtilities &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MeshDataTransferUtilities &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MesherUtilities &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MesherUtilities &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyForcesAndMomentsProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyForcesAndMomentsToWallsProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyKinematicConstraintsProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyKinematicConstraintsToWallsProcess &rThis)
 output stream function More...
 
template<class TConfigure >
std::istream & operator>> (std::istream &rIStream, BinsObjectDynamicPeriodic< TConfigure > &rThis)
 input stream function More...
 
template<class TConfigure >
std::ostream & operator<< (std::ostream &rOStream, const BinsObjectDynamicPeriodic< TConfigure > &rThis)
 output stream function More...
 
template<std::size_t TDimension>
std::istream & operator>> (std::istream &rIStream, DiscreteParticleConfigure< TDimension > &rThis)
 input stream function More...
 
template<std::size_t TDimension>
std::ostream & operator<< (std::ostream &rOStream, const DiscreteParticleConfigure< TDimension > &rThis)
 output stream function More...
 
template<std::size_t TDimension>
std::istream & operator>> (std::istream &rIStream, GeometricalConfigure< TDimension > &rThis)
 input stream function More...
 
template<std::size_t TDimension>
std::ostream & operator<< (std::ostream &rOStream, const GeometricalConfigure< TDimension > &rThis)
 output stream function More...
 
template<std::size_t TDimension>
std::istream & operator>> (std::istream &rIStream, RigidFaceGeometricalObjectConfigure< TDimension > &rThis)
 input stream function More...
 
template<std::size_t TDimension>
std::ostream & operator<< (std::ostream &rOStream, const RigidFaceGeometricalObjectConfigure< TDimension > &rThis)
 output stream function More...
 
template<class TElementData >
std::istream & operator>> (std::istream &rIStream, DropletDynamicsElement< TElementData > &rThis)
 input stream function More...
 
template<class TElementData >
std::ostream & operator<< (std::ostream &rOStream, const DropletDynamicsElement< TElementData > &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CalculateDivergenceProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CalculateDivergenceProcess &rThis)
 input stream function More...
 
template<unsigned int TDim, class TVarType >
std::istream & operator>> (std::istream &rIStream, MetricDivergenceFreeProcess< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim, class TVarType >
std::ostream & operator<< (std::ostream &rOStream, const MetricDivergenceFreeProcess< TDim > &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const WeightedDivergenceCalculationProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, WeightedDivergenceCalculationProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DragAndMomentUtilities &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AssignVectorFieldToEntitiesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AssignVectorFieldToEntitiesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AssignVectorVariableToConditionsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AssignVectorVariableToConditionsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, FixScalarDofProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FixScalarDofProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, FreeScalarDofProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FreeScalarDofProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TransferEntitiesBetweenModelPartsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TransferEntitiesBetweenModelPartsProcess &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, AdjointMonolithicWallCondition< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const AdjointMonolithicWallCondition< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, EmbeddedAusasNavierStokesWallCondition< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const EmbeddedAusasNavierStokesWallCondition< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, FSGeneralizedWallCondition< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const FSGeneralizedWallCondition< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, FSPeriodicCondition< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const FSPeriodicCondition< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, FSWernerWengleWallCondition< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const FSWernerWengleWallCondition< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, MonolithicWallCondition< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const MonolithicWallCondition< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes, class TWallModel >
std::istream & operator>> (std::istream &rIStream, NavierStokesWallCondition< TDim, TNumNodes, TWallModel > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes, class TWallModel >
std::ostream & operator<< (std::ostream &rOStream, const NavierStokesWallCondition< TDim, TNumNodes, TWallModel > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, StokesWallCondition< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const StokesWallCondition< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes, class TWallModel >
std::istream & operator>> (std::istream &rIStream, TwoFluidNavierStokesWallCondition< TDim, TNumNodes, TWallModel > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes, class TWallModel >
std::ostream & operator<< (std::ostream &rOStream, const TwoFluidNavierStokesWallCondition< TDim, TNumNodes, TWallModel > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, WallCondition< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const WallCondition< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, WallConditionDiscontinuous< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const WallConditionDiscontinuous< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<class TElementData >
std::istream & operator>> (std::istream &rIStream, AlternativeDVMSDEMCoupled< TElementData > &rThis)
 input stream function More...
 
template<class TElementData >
std::ostream & operator<< (std::ostream &rOStream, const AlternativeDVMSDEMCoupled< TElementData > &rThis)
 output stream function More...
 
template<class TElementData >
std::istream & operator>> (std::istream &rIStream, AlternativeQSVMSDEMCoupled< TElementData > &rThis)
 input stream function More...
 
template<class TElementData >
std::ostream & operator<< (std::ostream &rOStream, const AlternativeQSVMSDEMCoupled< TElementData > &rThis)
 output stream function More...
 
template<class TElementData >
std::istream & operator>> (std::istream &rIStream, AxisymmetricNavierStokes< TElementData > &rThis)
 input stream function More...
 
template<class TElementData >
std::ostream & operator<< (std::ostream &rOStream, const AxisymmetricNavierStokes< TElementData > &rThis)
 output stream function More...
 
template<class TBaseElement >
std::istream & operator>> (std::istream &rIStream, BinghamFluid< TBaseElement > &rThis)
 input stream function More...
 
template<class TBaseElement >
std::ostream & operator<< (std::ostream &rOStream, const BinghamFluid< TBaseElement > &rThis)
 output stream function More...
 
template<class TElementData >
std::istream & operator>> (std::istream &rIStream, DVMS< TElementData > &rThis)
 input stream function More...
 
template<class TElementData >
std::ostream & operator<< (std::ostream &rOStream, const DVMS< TElementData > &rThis)
 output stream function More...
 
template<class TElementData >
std::istream & operator>> (std::istream &rIStream, DVMSDEMCoupled< TElementData > &rThis)
 input stream function More...
 
template<class TElementData >
std::ostream & operator<< (std::ostream &rOStream, const DVMSDEMCoupled< TElementData > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, DistanceSmoothingElement< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const DistanceSmoothingElement< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, DPGVMS< TDim, TNumNodes > &rThis)
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const DPGVMS< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, DynamicVMS< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const DynamicVMS< TDim > &rThis)
 output stream function More...
 
template<class TElementData >
std::istream & operator>> (std::istream &rIStream, EmbeddedFluidElement< TElementData > &rThis)
 input stream function More...
 
template<class TElementData >
std::ostream & operator<< (std::ostream &rOStream, const EmbeddedFluidElement< TElementData > &rThis)
 output stream function More...
 
template<class TElementData >
std::istream & operator>> (std::istream &rIStream, EmbeddedFluidElementDiscontinuous< TElementData > &rThis)
 input stream function More...
 
template<class TElementData >
std::ostream & operator<< (std::ostream &rOStream, const EmbeddedFluidElementDiscontinuous< TElementData > &rThis)
 output stream function More...
 
template<class TElementData >
std::istream & operator>> (std::istream &rIStream, FIC< TElementData > &rThis)
 input stream function More...
 
template<class TElementData >
std::ostream & operator<< (std::ostream &rOStream, const FIC< TElementData > &rThis)
 output stream function More...
 
template<class TElementData >
std::istream & operator>> (std::istream &rIStream, FluidElement< TElementData > &rThis)
 input stream function More...
 
template<class TElementData >
std::ostream & operator<< (std::ostream &rOStream, const FluidElement< TElementData > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, FractionalStep< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const FractionalStep< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, FractionalStepDiscontinuous< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const FractionalStepDiscontinuous< TDim > &rThis)
 output stream function More...
 
template<class TBaseElement >
std::istream & operator>> (std::istream &rIStream, HerschelBulkleyFluid< TBaseElement > &rThis)
 input stream function More...
 
template<class TBaseElement >
std::ostream & operator<< (std::ostream &rOStream, const HerschelBulkleyFluid< TBaseElement > &rThis)
 output stream function More...
 
template<class TElementData >
std::istream & operator>> (std::istream &rIStream, QSVMS< TElementData > &rThis)
 input stream function More...
 
template<class TElementData >
std::ostream & operator<< (std::ostream &rOStream, const QSVMS< TElementData > &rThis)
 output stream function More...
 
template<class TElementData >
std::istream & operator>> (std::istream &rIStream, QSVMSDEMCoupled< TElementData > &rThis)
 input stream function More...
 
template<class TElementData >
std::ostream & operator<< (std::ostream &rOStream, const QSVMSDEMCoupled< TElementData > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SpalartAllmaras &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SpalartAllmaras &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, StationaryStokes< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const StationaryStokes< TDim > &rThis)
 output stream function More...
 
template<class TElementData >
std::istream & operator>> (std::istream &rIStream, SymbolicStokes< TElementData > &rThis)
 input stream function More...
 
template<class TElementData >
std::ostream & operator<< (std::ostream &rOStream, const SymbolicStokes< TElementData > &rThis)
 output stream function More...
 
template<class TElementData >
std::istream & operator>> (std::istream &rIStream, TwoFluidNavierStokes< TElementData > &rThis)
 input stream function More...
 
template<class TElementData >
std::ostream & operator<< (std::ostream &rOStream, const TwoFluidNavierStokes< TElementData > &rThis)
 output stream function More...
 
template<class TElementData >
std::istream & operator>> (std::istream &rIStream, TwoFluidNavierStokesAlphaMethod< TElementData > &rThis)
 input stream function More...
 
template<class TElementData >
std::ostream & operator<< (std::ostream &rOStream, const TwoFluidNavierStokesAlphaMethod< TElementData > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, TwoFluidVMS< TDim, TNumNodes > &rThis)
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const TwoFluidVMS< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, TwoFluidVMSLinearizedDarcy< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const TwoFluidVMSLinearizedDarcy< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, VMS< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const VMS< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, VMSAdjointElement< TDim > &rThis)
 Defines an input stream operator that does nothing. More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const VMSAdjointElement< TDim > &rThis)
 Defines an output stream operator that prints element info. More...
 
template<class TElementData >
std::istream & operator>> (std::istream &rIStream, WeaklyCompressibleNavierStokes< TElementData > &rThis)
 input stream function More...
 
template<class TElementData >
std::ostream & operator<< (std::ostream &rOStream, const WeaklyCompressibleNavierStokes< TElementData > &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ApplyCompressibleNavierStokesBoundaryConditionsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, WindkesselModel &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const WindkesselModel &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const BoussinesqForceProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ComputeYPlusProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, IntegrationPointStatisticsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const IntegrationPointStatisticsProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ShockCapturingEntropyViscosityProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ShockCapturingPhysicsBasedProcess &rThis)
 output stream function More...
 
template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::istream & operator>> (std::istream &rIStream, SpalartAllmarasTurbulenceModel< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 input stream function More...
 
template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::ostream & operator<< (std::ostream &rOStream, const SpalartAllmarasTurbulenceModel< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 output stream function More...
 
template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::istream & operator>> (std::istream &rIStream, StokesInitializationProcess< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 input stream function More...
 
template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::ostream & operator<< (std::ostream &rOStream, const StokesInitializationProcess< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 output stream function More...
 
template<class TSparseSpace , class TDenseSpace >
std::istream & operator>> (std::istream &rIStream, BDF2TurbulentScheme< TSparseSpace, TDenseSpace > &rThis)
 input stream function More...
 
template<class TSparseSpace , class TDenseSpace >
std::ostream & operator<< (std::ostream &rOStream, const BDF2TurbulentScheme< TSparseSpace, TDenseSpace > &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AccelerationLimitationUtilities &rThis)
 output stream function More...
 
template<class TLocalMatrixType , class TLocalVectorType >
std::istream & operator>> (std::istream &rIStream, CompressibleElementRotationUtility< TLocalMatrixType, TLocalVectorType > &rThis)
 input stream function More...
 
template<class TLocalMatrixType , class TLocalVectorType >
std::ostream & operator<< (std::ostream &rOStream, const CompressibleElementRotationUtility< TLocalMatrixType, TLocalVectorType > &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DragUtilities &rThis)
 output stream function More...
 
template<class TDenseSpace , class TSparseSpace , class TLinearSolver >
std::istream & operator>> (std::istream &rIStream, FractionalStepSettings< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 input stream function More...
 
template<class TDenseSpace , class TSparseSpace , class TLinearSolver >
std::ostream & operator<< (std::ostream &rOStream, const FractionalStepSettings< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 output stream function More...
 
template<class TDenseSpace , class TSparseSpace , class TLinearSolver >
std::istream & operator>> (std::istream &rIStream, FractionalStepSettingsPeriodic< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 input stream function More...
 
template<class TDenseSpace , class TSparseSpace , class TLinearSolver >
std::ostream & operator<< (std::ostream &rOStream, const FractionalStepSettingsPeriodic< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, PeriodicConditionUtilities &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const PeriodicConditionUtilities &rThis)
 output stream function More...
 
template<class TDenseSpace , class TSparseSpace , class TLinearSolver >
std::istream & operator>> (std::istream &rIStream, SolverSettings< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 input stream function More...
 
template<class TDenseSpace , class TSparseSpace , class TLinearSolver >
std::ostream & operator<< (std::ostream &rOStream, const SolverSettings< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, StatisticsData &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const StatisticsData &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, StatisticsRecord &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const StatisticsRecord &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, StatisticsSampler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const StatisticsSampler &rThis)
 output stream function More...
 
template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::istream & operator>> (std::istream &rIStream, TrilinosSpalartAllmarasTurbulenceModel< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 input stream function More...
 
template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::ostream & operator<< (std::ostream &rOStream, const TrilinosSpalartAllmarasTurbulenceModel< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 output stream function More...
 
template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::istream & operator>> (std::istream &rIStream, TrilinosStokesInitializationProcess< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 input stream function More...
 
template<class TSparseSpace , class TDenseSpace , class TLinearSolver >
std::ostream & operator<< (std::ostream &rOStream, const TrilinosStokesInitializationProcess< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 output stream function More...
 
template<class TDenseSpace , class TSparseSpace , class TLinearSolver >
std::istream & operator>> (std::istream &rIStream, TrilinosFractionalStepSettings< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 input stream function More...
 
template<class TDenseSpace , class TSparseSpace , class TLinearSolver >
std::ostream & operator<< (std::ostream &rOStream, const TrilinosFractionalStepSettings< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 output stream function More...
 
template<class TDenseSpace , class TSparseSpace , class TLinearSolver >
std::istream & operator>> (std::istream &rIStream, TrilinosFractionalStepSettingsPeriodic< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 input stream function More...
 
template<class TDenseSpace , class TSparseSpace , class TLinearSolver >
std::ostream & operator<< (std::ostream &rOStream, const TrilinosFractionalStepSettingsPeriodic< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, DeactivateConditionsOnInactiveElements &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const DeactivateConditionsOnInactiveElements &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, FindNeighbourElementsOfConditionsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FindNeighbourElementsOfConditionsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, IgaModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const IgaModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RefinementModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RefinementModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AssignIntegrationPointsToBackgroundElementsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AssignIntegrationPointsToBackgroundElementsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MapNurbsVolumeResultsToEmbeddedGeometryProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MapNurbsVolumeResultsToEmbeddedGeometryProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, OutputEigenValuesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const OutputEigenValuesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, OutputQuadratureDomainProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const OutputQuadratureDomainProcess &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType >
std::istream & operator>> (std::istream &IStream, AdditiveSchwarzPreconditioner< TSparseSpaceType, TDenseSpaceType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType >
std::ostream & operator<< (std::ostream &OStream, const AdditiveSchwarzPreconditioner< TSparseSpaceType, TDenseSpaceType > &rThis)
 output stream function More...
 
void RegisterDenseLinearSolvers ()
 
template<typename TGlobalSpace , typename TLocalSpace , typename TLinearSolverType >
std::ostream & operator<< (std::ostream &rOStream, const DenseLinearSolverFactory< TGlobalSpace, TLocalSpace, TLinearSolverType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MappingGeometriesModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MappingGeometriesModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, InterfaceObjectConfigure &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const InterfaceObjectConfigure &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MedModelPartIO &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MedModelPartIO &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MeshingFlags &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MeshingFlags &rThis)
 output stream function More...
 
template<MMGLibrary TMMGLibrary>
std::istream & operator>> (std::istream &rIStream, MmgIO< TMMGLibrary > &rThis)
 input stream function More...
 
template<MMGLibrary TMMGLibrary>
std::ostream & operator<< (std::ostream &rOStream, const MmgIO< TMMGLibrary > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, EmbeddedMeshLocatorProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const EmbeddedMeshLocatorProcess &rThis)
 output stream function More...
 
template<class TPointType , class TPointerType >
std::istream & operator>> (std::istream &rIStream, InternalVariablesInterpolationProcess &rThis)
 
template<class TPointType , class TPointerType >
std::ostream & operator<< (std::ostream &rOStream, const InternalVariablesInterpolationProcess &rThis)
 
template<unsigned int TDim, class TVarType >
std::istream & operator>> (std::istream &rIStream, MetricErrorProcess< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim, class TVarType >
std::ostream & operator<< (std::ostream &rOStream, const MetricErrorProcess< TDim > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ComputeHessianSolMetricProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ComputeHessianSolMetricProcess &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, ComputeLevelSetSolMetricProcess< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const ComputeLevelSetSolMetricProcess< TDim > &rThis)
 output stream function More...
 
template<MMGLibrary TMMGLibrary>
std::istream & operator>> (std::istream &rIStream, MmgProcess< TMMGLibrary > &rThis)
 input stream function More...
 
template<MMGLibrary TMMGLibrary>
std::ostream & operator<< (std::ostream &rOStream, const MmgProcess< TMMGLibrary > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MultiscaleRefiningProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MultiscaleRefiningProcess &rThis)
 output stream function More...
 
template<PMMGLibrary TPMMGLibrary>
std::istream & operator>> (std::istream &rIStream, ParMmgProcess< TPMMGLibrary > &rThis)
 input stream function More...
 
template<PMMGLibrary TPMMGLibrary>
std::ostream & operator<< (std::ostream &rOStream, const ParMmgProcess< TPMMGLibrary > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SetHMapProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SetHMapProcess &rThis)
 output stream function More...
 
template<std::size_t TDim>
std::ostream & operator<< (std::ostream &rOStream, const BinBasedMeshTransfer< TDim > &rThis)
 output stream function More...
 
template<MMGLibrary TMMGLibrary>
std::istream & operator>> (std::istream &rIStream, MmgUtilities< TMMGLibrary > &rThis)
 input stream function More...
 
template<MMGLibrary TMMGLibrary>
std::ostream & operator<< (std::ostream &rOStream, const MmgUtilities< TMMGLibrary > &rThis)
 output stream function More...
 
template<PMMGLibrary TPMMGLibrary>
std::istream & operator>> (std::istream &rIStream, ParMmgUtilities< TPMMGLibrary > &rThis)
 input stream function More...
 
template<PMMGLibrary TPMMGLibrary>
std::ostream & operator<< (std::ostream &rOStream, const ParMmgUtilities< TPMMGLibrary > &rThis)
 output stream function More...
 
template<std::size_t TDim>
std::ostream & operator<< (std::ostream &rOStream, const MeshTransfer< TDim > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TetgenVolumeMesher &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TetgenVolumeMesher &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TetrahedraReconnectUtility &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TetrahedraReconnectUtility &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, UniformRefinementUtility &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const UniformRefinementUtility &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MSuitePFEMModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MSuitePFEMModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TetGenCDT &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TetGenCDT &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TetGenPfemContact &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TetGenPfemContact &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TetGenPfemModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TetGenPfemModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TetGenPfemRefineFace &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TetGenPfemRefineFace &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TetGenPfemModelerVms &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TetGenPfemModelerVms &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TriGenCDT &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TriGenCDT &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TriGenPFEMModeler &rThis)
 input stream function More...
 
std::istream & operator>> (std::istream &rIStream, TriGenDropletModeler &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TriGenDropletModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TriGenGLASSModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TriGenGLASSModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TriGenModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TriGenModeler &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TriGenPFEMModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TriGenPFEMRefineSegment &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TriGenPFEMRefineSegment &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TriGenPFEMModelerVMS &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TriGenPFEMModelerVMS &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FixedMeshALEUtilities &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MetisDivideHeterogeneousInputProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MetisDivideHeterogeneousInputProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MortonDivideInputToPartitionsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MortonDivideInputToPartitionsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MortonPartitioningProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MortonPartitioningProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CollectiveExpression &rThis)
 output stream function More...
 
template<class TContainerType >
std::ostream & operator<< (std::ostream &rOStream, const ExplicitFilter< TContainerType > &rThis)
 output stream function More...
 
template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension, int TDimension>
std::istream & operator>> (std::istream &rIStream, QuadraturePointPartitionedGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension > &rThis)
 input stream function More...
 
template<class TPointType , int TWorkingSpaceDimension, int TLocalSpaceDimension, int TDimension>
std::ostream & operator<< (std::ostream &rOStream, const QuadraturePointPartitionedGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ParticleEraseProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ParticleEraseProcess &rThis)
 output stream function More...
 
template<class TLocalMatrixType , class TLocalVectorType >
std::istream & operator>> (std::istream &rIStream, MPMBoundaryRotationUtility< TLocalMatrixType, TLocalVectorType > &rThis)
 input stream function More...
 
template<class TLocalMatrixType , class TLocalVectorType >
std::ostream & operator<< (std::ostream &rOStream, const MPMBoundaryRotationUtility< TLocalMatrixType, TLocalVectorType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MonolithicAutoSlipInlet3D &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const MonolithicAutoSlipInlet3D< TDim, TNumNodes > &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MonolithicAutoSlipInlet3D &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MarkFluidProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MarkFluidProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MarkOuterNodesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MarkOuterNodesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SaveLagrangianSurfaceProcess_p &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SaveLagrangianSurfaceProcess_p &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, Pfem2ApplyBCProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const Pfem2ApplyBCProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AdaptiveTimeIntervalProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AdaptiveTimeIntervalProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AssignPropertiesToNodesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AssignPropertiesToNodesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, InletMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const InletMesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, InsertFluidNodesMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const InsertFluidNodesMesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ManageIsolatedNodesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ManageIsolatedNodesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ManageSelectedElementsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ManageSelectedElementsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RecoverVolumeLossesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RecoverVolumeLossesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RefineFluidElementsInEdgesMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RefineFluidElementsInEdgesMesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RemoveFluidNodesMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RemoveFluidNodesMesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, VolumeShapingProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const VolumeShapingProcess &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, ThreeStepFirstOrderUpdatedLagrangianElement< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const ThreeStepFirstOrderUpdatedLagrangianElement< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, ThreeStepSecondOrderPspgUpdatedLagrangianElement< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const ThreeStepSecondOrderPspgUpdatedLagrangianElement< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, ThreeStepSecondOrderUpdatedLagrangianElement< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const ThreeStepSecondOrderUpdatedLagrangianElement< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, ThreeStepUpdatedLagrangianElement< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const ThreeStepUpdatedLagrangianElement< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, TwoStepUpdatedLagrangianElement< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const TwoStepUpdatedLagrangianElement< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, TwoStepUpdatedLagrangianVPImplicitElement< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const TwoStepUpdatedLagrangianVPImplicitElement< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const TwoStepUpdatedLagrangianVPImplicitFluidDEMcouplingElement< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, TwoStepUpdatedLagrangianVPImplicitFluidElement< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const TwoStepUpdatedLagrangianVPImplicitFluidElement< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, TwoStepUpdatedLagrangianVPImplicitFluidFicElement< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const TwoStepUpdatedLagrangianVPImplicitFluidFicElement< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const TwoStepUpdatedLagrangianVPImplicitFluidPspgElement< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedElement< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedFluidElement< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const TwoStepUpdatedLagrangianVPImplicitNodallyIntegratedSolidElement< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, TwoStepUpdatedLagrangianVPImplicitSolidElement< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const TwoStepUpdatedLagrangianVPImplicitSolidElement< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, UpdatedLagrangianElement< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const UpdatedLagrangianElement< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, UpdatedLagrangianVImplicitSolidElement< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const UpdatedLagrangianVImplicitSolidElement< TDim > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AssignScalarFieldToPfemEntitiesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AssignScalarFieldToPfemEntitiesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AssignScalarVariableToPfemEntitiesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AssignScalarVariableToPfemEntitiesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AssignVectorFieldToPfemEntitiesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AssignVectorFieldToPfemEntitiesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AssignVectorVariableToPfemConditionsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AssignVectorVariableToPfemConditionsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, BuildMeshBoundaryForFluidsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const BuildMeshBoundaryForFluidsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, BuildModelPartBoundaryForFluidsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const BuildModelPartBoundaryForFluidsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CalculateWaveHeightProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CalculateWaveHeightProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ComputeAveragePfemMeshParametersProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ComputeAveragePfemMeshParametersProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, FindNodalHForRigidWallsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FindNodalHForRigidWallsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, FixScalarPfemDofProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FixScalarPfemDofProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, FreeScalarPfemDofProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FreeScalarPfemDofProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, GenerateNewConditionsMesherForFluidsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const GenerateNewConditionsMesherForFluidsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, GenerateNewNodesBeforeMeshingProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const GenerateNewNodesBeforeMeshingProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, InletManagementProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const InletManagementProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ModelStartEndMeshingForFluidsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ModelStartEndMeshingForFluidsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RemoveMeshNodesForFluidsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RemoveMeshNodesForFluidsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SelectMeshElementsForFluidsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SelectMeshElementsForFluidsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SetActiveFlagMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SetActiveFlagMesherProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SetActiveFlagProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SetActiveFlagProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SetEulerianInletProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SetEulerianInletProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SetLagrangianInletProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SetLagrangianInletProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SetMainMaterialPropertyProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SetMainMaterialPropertyProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SetMaterialPropertiesFromFluidToRigidNodesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SetMaterialPropertiesFromFluidToRigidNodesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SetMaterialPropertiesToFluidNodesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SetMaterialPropertiesToFluidNodesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SetMaterialPropertiesToSolidNodesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SetMaterialPropertiesToSolidNodesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SplitElementsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SplitElementsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TransferModelPartElementsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TransferModelPartElementsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, UpdateConditionsOnFreeSurfaceProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const UpdateConditionsOnFreeSurfaceProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CalculateWaveHeightUtility &rThis)
 output stream function More...
 
template<class TDenseSpace , class TSparseSpace , class TLinearSolver >
std::istream & operator>> (std::istream &rIStream, TwoStepVPSolverSettings< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 input stream function More...
 
template<class TDenseSpace , class TSparseSpace , class TLinearSolver >
std::ostream & operator<< (std::ostream &rOStream, const TwoStepVPSolverSettings< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 output stream function More...
 
template<class TDenseSpace , class TSparseSpace , class TLinearSolver >
std::istream & operator>> (std::istream &rIStream, TwoStepVPSettings< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 input stream function More...
 
template<class TDenseSpace , class TSparseSpace , class TLinearSolver >
std::ostream & operator<< (std::ostream &rOStream, const TwoStepVPSettings< TSparseSpace, TDenseSpace, TLinearSolver > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RefineConditionsInContactMesherProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RefineConditionsInContactMesherProcess &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, FractionalStepKBasedWallCondition< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const FractionalStepKBasedWallCondition< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, IncompressiblePotentialFlowVelocityInletCondition< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const IncompressiblePotentialFlowVelocityInletCondition< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes, class TScalarWallFluxConditionData >
std::istream & operator>> (std::istream &rIStream, ScalarWallFluxCondition< TDim, TNumNodes, TScalarWallFluxConditionData > &rThis)
 
template<unsigned int TDim, unsigned int TNumNodes, class TScalarWallFluxConditionData >
std::ostream & operator<< (std::ostream &rOStream, const ScalarWallFluxCondition< TDim, TNumNodes, TScalarWallFluxConditionData > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, VMSMonolithicKBasedWallCondition< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const VMSMonolithicKBasedWallCondition< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes, class TConvectionDiffusionReactionData >
std::istream & operator>> (std::istream &rIStream, ConvectionDiffusionReactionCrossWindStabilizedElement< TDim, TNumNodes, TConvectionDiffusionReactionData > &rThis)
 
template<unsigned int TDim, unsigned int TNumNodes, class TConvectionDiffusionReactionData >
std::ostream & operator<< (std::ostream &rOStream, const ConvectionDiffusionReactionCrossWindStabilizedElement< TDim, TNumNodes, TConvectionDiffusionReactionData > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes, class TConvectionDiffusionReactionData >
std::istream & operator>> (std::istream &rIStream, ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData > &rThis)
 
template<unsigned int TDim, unsigned int TNumNodes, class TConvectionDiffusionReactionData >
std::ostream & operator<< (std::ostream &rOStream, const ConvectionDiffusionReactionElement< TDim, TNumNodes, TConvectionDiffusionReactionData > &rThis)
 output stream function More...
 
template<IndexType TDim, IndexType TNumNodes, class TConvectionDiffusionReactionData >
std::istream & operator>> (std::istream &rIStream, ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< TDim, TNumNodes, TConvectionDiffusionReactionData > &rThis)
 
template<IndexType TDim, IndexType TNumNodes, class TConvectionDiffusionReactionData >
std::ostream & operator<< (std::ostream &rOStream, const ConvectionDiffusionReactionResidualBasedFluxCorrectedElement< TDim, TNumNodes, TConvectionDiffusionReactionData > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, IncompressiblePotentialFlowVelocityElement< TDim, TNumNodes > &rThis)
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const IncompressiblePotentialFlowVelocityElement< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, LaplaceElement< TDim, TNumNodes > &rThis)
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const LaplaceElement< TDim, TNumNodes > &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RansApplyExactNodalPeriodicConditionProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RansApplyFlagToSkinProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RansClipScalarVariableProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RansComputeReactionsProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RansEpsilonTurbulentMixingLengthInletProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RansFormulationProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RansFormulationProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RansKTurbulentIntensityInletProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RansLineOutputProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RansNutKEpsilonUpdateProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RansNutKOmegaSSTUpdateProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RansNutKOmegaUpdateProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RansNutNodalUpdateProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RansNutYPlusWallFunctionUpdateProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RansOmegaTurbulentMixingLengthInletProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RansWallDistanceCalculationProcess &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RansWallFunctionUpdateProcess &rThis)
 output stream function More...
 
template<class TSparseSpace >
std::istream & operator>> (std::istream &rIStream, RelaxedDofUpdater< TSparseSpace > &rThis)
 input stream function More...
 
template<class TSparseSpace >
std::ostream & operator<< (std::ostream &rOStream, const RelaxedDofUpdater< TSparseSpace > &rThis)
 output stream function More...
 
template<typename TDataType >
std::istream & operator>> (std::istream &rIStream, RansVariableDifferenceNormsCalculationUtility< TDataType > &rThis)
 
template<typename TDataType >
std::ostream & operator<< (std::ostream &rOStream, const RansVariableDifferenceNormsCalculationUtility< TDataType > &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ChezyLaw &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ManningLaw &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const NodalManningLaw &rThis)
 output stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const WindWaterFriction &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MeshMovingModeler &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MeshMovingModeler &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CalculateDistanceToBoundaryProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CalculateDistanceToBoundaryProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, EstimateTimeStepUtility &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const EstimateTimeStepUtility &rThis)
 output stream function More...
 
template<class TLocalMatrixType , class TLocalVectorType , class TValueType >
std::istream & operator>> (std::istream &rIStream, FlowRateSlipUtility< TLocalMatrixType, TLocalVectorType, TValueType > &rThis)
 input stream function More...
 
template<class TLocalMatrixType , class TLocalVectorType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const FlowRateSlipUtility< TLocalMatrixType, TLocalVectorType, TValueType > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MoveShallowMeshUtility &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MoveShallowMeshUtility &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AddDofsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AddDofsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AssignFlagsToModelPartEntitiesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AssignFlagsToModelPartEntitiesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AssignRotationAboutAnAxisToNodesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AssignRotationAboutAnAxisToNodesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AssignRotationFieldAboutAnAxisToNodesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AssignRotationFieldAboutAnAxisToNodesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AssignTorqueAboutAnAxisToConditionsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AssignTorqueAboutAnAxisToConditionsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AssignTorqueFieldAboutAnAxisToConditionsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AssignTorqueFieldAboutAnAxisToConditionsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, BuildStringSkinProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const BuildStringSkinProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ManageTimeStepProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ManageTimeStepProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SolverProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SolverProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TimeDiscretizationProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TimeDiscretizationProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, TransferSolvingModelPartEntitiesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const TransferSolvingModelPartEntitiesProcess &rThis)
 output stream function More...
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, BackwardEulerMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const BackwardEulerMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, BdfMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const BdfMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, BossakMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const BossakMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, BossakStepMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const BossakStepMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, BossakStepRotationMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const BossakStepRotationMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, EmcStepMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const EmcStepMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, EmcStepRotationMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const EmcStepRotationMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, NewmarkMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const NewmarkMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, NewmarkStepMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const NewmarkStepMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, NewmarkStepRotationMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const NewmarkStepRotationMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, SimoMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const SimoMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, SimoStepMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const SimoStepMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, SimoStepRotationMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const SimoStepRotationMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, StaticMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const StaticMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, StaticStepMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const StaticStepMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, StaticStepRotationMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const StaticStepRotationMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, TimeIntegrationMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const TimeIntegrationMethod< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::istream & operator>> (std::istream &rIStream, TimeIntegrationMethodsContainer< TVariableType, TValueType > &rThis)
 
template<class TVariableType , class TValueType >
std::ostream & operator<< (std::ostream &rOStream, const TimeIntegrationMethodsContainer< TVariableType, TValueType > &rThis)
 
template<std::size_t TDim>
std::istream & operator>> (std::istream &rIStream, LineLoadCondition< TDim > &rThis)
 input stream function More...
 
template<std::size_t TDim>
std::ostream & operator<< (std::ostream &rOStream, const LineLoadCondition< TDim > &rThis)
 output stream function More...
 
template<std::size_t TDim, std::size_t TNumNodes>
std::istream & operator>> (std::istream &rIStream, MovingLoadCondition< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<std::size_t TDim, std::size_t TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const MovingLoadCondition< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<std::size_t TDim>
std::istream & operator>> (std::istream &rIStream, SmallDisplacementLineLoadCondition< TDim > &rThis)
 input stream function More...
 
template<std::size_t TDim>
std::ostream & operator<< (std::ostream &rOStream, const SmallDisplacementLineLoadCondition< TDim > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MassElement &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MassElement &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ImposeRigidMovementProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ImposeRigidMovementProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, PrismNeighboursProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const PrismNeighboursProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, ReplaceMultipleElementsAndConditionsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const ReplaceMultipleElementsAndConditionsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, NodeConfigureForNodeSearch &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const NodeConfigureForNodeSearch &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, ComputeLaplacianSimplexCondition< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const ComputeLaplacianSimplexCondition< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, MonolithicDEMCoupledWallCondition< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const MonolithicDEMCoupledWallCondition< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, ComputeComponentGradientSimplex< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const ComputeComponentGradientSimplex< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, ComputeGradientPouliot2012< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const ComputeGradientPouliot2012< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, ComputeGradientPouliot2012Edge< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const ComputeGradientPouliot2012Edge< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, ComputeLaplacianSimplex< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const ComputeLaplacianSimplex< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, ComputeMaterialDerivativeSimplex< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const ComputeMaterialDerivativeSimplex< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, ComputeVelocityLaplacianSimplex< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const ComputeVelocityLaplacianSimplex< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & operator>> (std::istream &rIStream, ComputeVelocityLaplacianComponentSimplex< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & operator<< (std::ostream &rOStream, const ComputeVelocityLaplacianComponentSimplex< TDim > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, MonolithicDEMCoupled< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const MonolithicDEMCoupled< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, MonolithicDEMCoupledWeak< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const MonolithicDEMCoupledWeak< TDim, TNumNodes > &rThis)
 output stream function More...
 
template<class TSparseSpace , class TDenseSpace >
std::istream & operator>> (std::istream &rIStream, BDF2TurbulentSchemeDEMCoupled< TSparseSpace, TDenseSpace > &rThis)
 input stream function More...
 
template<class TSparseSpace , class TDenseSpace >
std::ostream & operator<< (std::ostream &rOStream, const BDF2TurbulentSchemeDEMCoupled< TSparseSpace, TDenseSpace > &rThis)
 output stream function More...
 
template<std::size_t TDim>
std::ostream & operator<< (std::ostream &rOStream, const DerivativeRecovery< TDim > &rThis)
 output stream function More...
 
template<std::size_t TDim>
std::ostream & operator<< (std::ostream &rOStream, const DerivativeRecoveryMeshingTools< TDim > &rThis)
 output stream function More...
 
template<std::size_t TDim>
std::ostream & operator<< (std::ostream &rOStream, const EmbeddedVolumeTool< TDim > &rThis)
 output stream function More...
 
template<std::size_t TDimension>
std::istream & operator>> (std::istream &rIStream, MpiDiscreteParticleConfigure< TDimension > &rThis)
 input stream function More...
 
template<std::size_t TDimension>
std::ostream & operator<< (std::ostream &rOStream, const MpiDiscreteParticleConfigure< TDimension > &rThis)
 output stream function More...
 
template<std::size_t TDimension>
std::istream & operator>> (std::istream &rIStream, PointConfigure< TDimension > &rThis)
 input stream function More...
 
template<std::size_t TDimension>
std::ostream & operator<< (std::ostream &rOStream, const PointConfigure< TDimension > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, FlowStationarityCheck &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FlowStationarityCheck &rThis)
 output stream function More...
 
template<std::size_t TDim>
std::ostream & operator<< (std::ostream &rOStream, const VolumeAveragingTool< TDim > &rThis)
 output stream function More...
 
template<typename TSparseSpace , typename TLocalSpace , typename TLinearSolverType >
std::ostream & operator<< (std::ostream &rOStream, const TrilinosLinearSolverFactory< TSparseSpace, TLocalSpace, TLinearSolverType > &rThis)
 output stream function More...
 
template<class TSparseSpace >
std::istream & operator>> (std::istream &rIStream, TrilinosDofUpdater< TSparseSpace > &rThis)
 input stream function More...
 
template<class TSparseSpace >
std::ostream & operator<< (std::ostream &rOStream, const TrilinosDofUpdater< TSparseSpace > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::istream & operator>> (std::istream &IStream, TrilinosMonotonicityPreservingSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 input stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::ostream & operator<< (std::ostream &OStream, const TrilinosMonotonicityPreservingSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 output stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::istream & operator>> (std::istream &rIStream, SurfaceTension< TDim, TNumNodes > &rThis)
 input stream function More...
 
template<unsigned int TDim, unsigned int TNumNodes>
std::ostream & operator<< (std::ostream &rOStream, const SurfaceTension< TDim, TNumNodes > &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AddWallProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AddWallProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, AssignSurfaceTensionConditions &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const AssignSurfaceTensionConditions &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CalculateAdhesionForce &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CalculateAdhesionForce &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CalculateContactAngle &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CalculateContactAngle &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CalculateCurvature &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CalculateCurvature &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CalculateNodalLength &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CalculateNodalLength &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, CalculateNormalEq &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const CalculateNormalEq &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, FindNodalNeighboursSurfaceProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const FindNodalNeighboursSurfaceProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, HypoelasticStressCalculateProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const HypoelasticStressCalculateProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, LagrangianInletProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const LagrangianInletProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MarkBadElementsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MarkBadElementsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MarkCloseNodesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MarkCloseNodesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MarkFreeSurfaceProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MarkFreeSurfaceProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MassCalculateProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MassCalculateProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, MergeModelPartsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MergeModelPartsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, PressureCalculateProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const PressureCalculateProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, PressureCalculateProcessAxisym &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const PressureCalculateProcessAxisym &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, RemoveAndSaveWallNodesProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const RemoveAndSaveWallNodesProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SaveFluidOnlyProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SaveFluidOnlyProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SaveStructureConditionsProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SaveStructureConditionsProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, SaveStructureModelPartProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const SaveStructureModelPartProcess &rThis)
 output stream function More...
 
std::istream & operator>> (std::istream &rIStream, UlfTimeStepDecProcess &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const UlfTimeStepDecProcess &rThis)
 output stream function More...
 
Arithmetic Operators
Expression::Pointer operator+ (const Expression::ConstPointer &rpLeft, const double Right)
 
Expression::Pointer operator+ (const double Left, const Expression::ConstPointer &rpRight)
 
Expression::Pointer operator+ (const Expression::ConstPointer &rpLeft, const Expression::ConstPointer &rpRight)
 
Expression::Pointer operator- (const Expression::ConstPointer &rpLeft, const double Right)
 
Expression::Pointer operator- (const double Left, const Expression::ConstPointer &rpRight)
 
Expression::Pointer operator- (const Expression::ConstPointer &rpLeft, const Expression::ConstPointer &rpRight)
 
Expression::Pointer operator* (const Expression::ConstPointer &rpLeft, const double Right)
 
Expression::Pointer operator* (const double Left, const Expression::ConstPointer &rpRight)
 
Expression::Pointer operator* (const Expression::ConstPointer &rpLeft, const Expression::ConstPointer &rpRight)
 
Expression::Pointer operator/ (const Expression::ConstPointer &rpLeft, const double Right)
 
Expression::Pointer operator/ (const double Left, const Expression::ConstPointer &rpRight)
 
Expression::Pointer operator/ (const Expression::ConstPointer &rpLeft, const Expression::ConstPointer &rpRight)
 
template<class TContainerType , MeshType TMeshType>
ContainerExpression< TContainerType, TMeshType > operator+ (const ContainerExpression< TContainerType, TMeshType > &rLeft, const double Right)
 
template<class TContainerType , MeshType TMeshType>
ContainerExpression< TContainerType, TMeshType > operator+ (const double Left, const ContainerExpression< TContainerType, TMeshType > &rRight)
 
template<class TContainerType , MeshType TMeshType>
ContainerExpression< TContainerType, TMeshType > operator+ (const ContainerExpression< TContainerType, TMeshType > &rLeft, const ContainerExpression< TContainerType, TMeshType > &rRight)
 
template<class TContainerType , MeshType TMeshType>
ContainerExpression< TContainerType, TMeshType > operator- (const ContainerExpression< TContainerType, TMeshType > &rLeft, const double Right)
 
template<class TContainerType , MeshType TMeshType>
ContainerExpression< TContainerType, TMeshType > operator- (const double Left, const ContainerExpression< TContainerType, TMeshType > &rRight)
 
template<class TContainerType , MeshType TMeshType>
ContainerExpression< TContainerType, TMeshType > operator- (const ContainerExpression< TContainerType, TMeshType > &rLeft, const ContainerExpression< TContainerType, TMeshType > &rRight)
 
template<class TContainerType , MeshType TMeshType>
ContainerExpression< TContainerType, TMeshType > operator* (const ContainerExpression< TContainerType, TMeshType > &rLeft, const double Right)
 
template<class TContainerType , MeshType TMeshType>
ContainerExpression< TContainerType, TMeshType > operator* (const double Left, const ContainerExpression< TContainerType, TMeshType > &rRight)
 
template<class TContainerType , MeshType TMeshType>
ContainerExpression< TContainerType, TMeshType > operator* (const ContainerExpression< TContainerType, TMeshType > &rLeft, const ContainerExpression< TContainerType, TMeshType > &rRight)
 
template<class TContainerType , MeshType TMeshType>
ContainerExpression< TContainerType, TMeshType > operator/ (const ContainerExpression< TContainerType, TMeshType > &rLeft, const double Right)
 
template<class TContainerType , MeshType TMeshType>
ContainerExpression< TContainerType, TMeshType > operator/ (const double Left, const ContainerExpression< TContainerType, TMeshType > &rRight)
 
template<class TContainerType , MeshType TMeshType>
ContainerExpression< TContainerType, TMeshType > operator/ (const ContainerExpression< TContainerType, TMeshType > &rLeft, const ContainerExpression< TContainerType, TMeshType > &rRight)
 
CollectiveExpression operator+ (const CollectiveExpression &rLeft, const double Right)
 
CollectiveExpression operator+ (const double Left, const CollectiveExpression &rRight)
 
CollectiveExpression operator+ (const CollectiveExpression &rLeft, const CollectiveExpression &rRight)
 
CollectiveExpression operator- (const CollectiveExpression &rLeft, const double Right)
 
CollectiveExpression operator- (const double Left, const CollectiveExpression &rRight)
 
CollectiveExpression operator- (const CollectiveExpression &rLeft, const CollectiveExpression &rRight)
 
CollectiveExpression operator* (const CollectiveExpression &rLeft, const double Right)
 
CollectiveExpression operator* (const double Left, const CollectiveExpression &rRight)
 
CollectiveExpression operator* (const CollectiveExpression &rLeft, const CollectiveExpression &rRight)
 
CollectiveExpression operator/ (const CollectiveExpression &rLeft, const double Right)
 
CollectiveExpression operator/ (const double Left, const CollectiveExpression &rRight)
 
CollectiveExpression operator/ (const CollectiveExpression &rLeft, const CollectiveExpression &rRight)
 
Operators
bool operator<< (Chunk const &rFirst, Chunk const &rSedond)
 
std::ostream & operator<< (std::ostream &rOStream, const Chunk &rThis)
 output stream function More...
 
Operations
template<class TDataType >
bool operator> (Dof< TDataType > const &First, Dof< TDataType > const &Second)
 Greater than operator. More...
 
template<class TDataType >
bool operator< (Dof< TDataType > const &First, Dof< TDataType > const &Second)
 Less than operator. More...
 
template<class TDataType >
bool operator>= (Dof< TDataType > const &First, Dof< TDataType > const &Second)
 Greater equal operator. More...
 
template<class TDataType >
bool operator<= (Dof< TDataType > const &First, Dof< TDataType > const &Second)
 Less equal operator. More...
 
template<class TDataType >
bool operator== (Dof< TDataType > const &First, Dof< TDataType > const &Second)
 Equal operator. More...
 
Kratos Globals
 KRATOS_CREATE_FLAG (STRUCTURE, 63)
 
 KRATOS_CREATE_FLAG (FLUID, 62)
 
 KRATOS_CREATE_FLAG (THERMAL, 61)
 
 KRATOS_CREATE_FLAG (VISITED, 60)
 
 KRATOS_CREATE_FLAG (SELECTED, 59)
 
 KRATOS_CREATE_FLAG (BOUNDARY, 58)
 
 KRATOS_CREATE_FLAG (INLET, 57)
 
 KRATOS_CREATE_FLAG (OUTLET, 56)
 
 KRATOS_CREATE_FLAG (SLIP, 55)
 
 KRATOS_CREATE_FLAG (INTERFACE, 54)
 
 KRATOS_CREATE_FLAG (CONTACT, 53)
 
 KRATOS_CREATE_FLAG (TO_SPLIT, 52)
 
 KRATOS_CREATE_FLAG (TO_ERASE, 51)
 
 KRATOS_CREATE_FLAG (TO_REFINE, 50)
 
 KRATOS_CREATE_FLAG (NEW_ENTITY, 49)
 
 KRATOS_CREATE_FLAG (OLD_ENTITY, 48)
 
 KRATOS_CREATE_FLAG (ACTIVE, 47)
 
 KRATOS_CREATE_FLAG (MODIFIED, 46)
 
 KRATOS_CREATE_FLAG (RIGID, 45)
 
 KRATOS_CREATE_FLAG (SOLID, 44)
 
 KRATOS_CREATE_FLAG (MPI_BOUNDARY, 43)
 
 KRATOS_CREATE_FLAG (INTERACTION, 42)
 
 KRATOS_CREATE_FLAG (ISOLATED, 41)
 
 KRATOS_CREATE_FLAG (MASTER, 40)
 
 KRATOS_CREATE_FLAG (SLAVE, 39)
 
 KRATOS_CREATE_FLAG (INSIDE, 38)
 
 KRATOS_CREATE_FLAG (FREE_SURFACE, 37)
 
 KRATOS_CREATE_FLAG (BLOCKED, 36)
 
 KRATOS_CREATE_FLAG (MARKER, 35)
 
 KRATOS_CREATE_FLAG (PERIODIC, 34)
 
 KRATOS_CREATE_FLAG (WALL, 33)
 
const Flags ALL_DEFINED (Flags::AllDefined())
 
const Flags ALL_TRUE (Flags::AllTrue())
 
 KRATOS_CREATE_LOCAL_FLAG (PFEMFlags, EULERIAN_INLET, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (PFEMFlags, LAGRANGIAN_INLET, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (PFEMFlags, PREVIOUS_FREESURFACE, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (PFEMFlags, PREVIOUS_ISOLATED, 3)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, NORMALIZED_SURFACE_NORMAL)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DF1DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DF1DX_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC1DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC2DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC3DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC4DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC5DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC6DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC7DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC8DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC9DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC1DX_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC2DX_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC3DX_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC4DX_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC5DX_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC6DX_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC7DX_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC8DX_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC9DX_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, SEARCH_DIRECTION)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, INV_HESSIAN)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, CORRECTION)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, PROJECTION)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, CONTROL_POINT_UPDATE)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, CONTROL_POINT_CHANGE)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, SHAPE_UPDATE)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, SHAPE_CHANGE)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, MESH_CHANGE)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DAMPING_FACTOR)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, int, MAPPING_ID)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, VERTEX_MORPHING_RADIUS)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, VERTEX_MORPHING_RADIUS_RAW)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, GAUSSIAN_CURVATURE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, MAX_NEIGHBOUR_DISTANCE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, ALPHA)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, ALPHA_MAPPED)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, DF1DALPHA)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, DF1DALPHA_MAPPED)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, DPDALPHA)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, DPDALPHA_MAPPED)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, DLDALPHA)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, BEAD_DIRECTION)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DP1DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DPF1DX)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, SCALAR_VARIABLE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, SCALAR_VARIABLE_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, VECTOR_VARIABLE)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, VECTOR_VARIABLE_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, BACKGROUND_COORDINATE)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, BACKGROUND_NORMAL)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, OUT_OF_PLANE_DELTA)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, bool, CONSIDER_FACE_ANGLE)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, HEATMAP_DF1DX)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, HEATMAP_DF1DALPHA)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, HEATMAP_DC1DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, HEATMAP_DC2DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, HEATMAP_DC3DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, HEATMAP_DC4DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, HEATMAP_DC5DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, HEATMAP_DC6DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, HEATMAP_DC7DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, HEATMAP_DC8DX)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, HEATMAP_DC9DX)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, HEATMAP_MAX)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, HEATMAP_L2)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DF1DX_WEIGHTED)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, DF1DALPHA_WEIGHTED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC1DX_WEIGHTED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC2DX_WEIGHTED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC3DX_WEIGHTED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC4DX_WEIGHTED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC5DX_WEIGHTED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC6DX_WEIGHTED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC7DX_WEIGHTED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC8DX_WEIGHTED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC9DX_WEIGHTED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DF1DX_WEIGHTED_MAPPED)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (SHAPE_OPTIMIZATION_APPLICATION, double, DF1DALPHA_WEIGHTED_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC1DX_WEIGHTED_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC2DX_WEIGHTED_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC3DX_WEIGHTED_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC4DX_WEIGHTED_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC5DX_WEIGHTED_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC6DX_WEIGHTED_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC7DX_WEIGHTED_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC8DX_WEIGHTED_MAPPED)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (SHAPE_OPTIMIZATION_APPLICATION, DC9DX_WEIGHTED_MAPPED)
 
Input/Output functions
std::istream & operator>> (std::istream &rIStream, MasterSlaveConstraint &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const MasterSlaveConstraint &rThis)
 output stream function More...
 
Local Flags
 KRATOS_CREATE_LOCAL_FLAG (IntegrationInfo, DO_NOT_CREATE_TESSELLATION_ON_SLAVE, 0)
 

Variables

PARTICLE_COHESION I33 BEAM_INERTIA_ROT_UNIT_LENGHT_Y KRATOS_CREATE_VARIABLE(double, BEAM_INERTIA_ROT_UNIT_LENGHT_Z) typedef std K_ALPHA NEIGHBOUR_PARTICLE_OF_RIGID_FACE HAS_ROTATION
 
KRATOS_API_EXTERN template class KratosComponents< LinearSolverFactoryType >
 
KRATOS_API_EXTERN template class KratosComponents< ComplexLinearSolverFactoryType >
 
KRATOS_API_EXTERN template class KratosComponents< PreconditionerFactoryType >
 
KRATOS_API_EXTERN template class KratosComponents< ExplicitBuilderType >
 
KRATOS_API_EXTERN template class KratosComponents< Geometry< Node > >
 
KRATOS_API_EXTERN template class KratosComponents< Condition >
 
KRATOS_API_EXTERN template class KratosComponents< ConstitutiveLaw >
 
KRATOS_API_EXTERN template class KratosComponents< Element >
 
KRATOS_API_EXTERN template class KratosComponents< Variable< bool > >
 
KRATOS_API_EXTERN template class KratosComponents< Variable< int > >
 
KRATOS_API_EXTERN template class KratosComponents< Variable< unsigned int > >
 
KRATOS_API_EXTERN template class KratosComponents< Variable< double > >
 
KRATOS_API_EXTERN template class KratosComponents< Variable< array_1d< double, 3 > > >
 
KRATOS_API_EXTERN template class KratosComponents< Variable< array_1d< double, 4 > > >
 
KRATOS_API_EXTERN template class KratosComponents< Variable< array_1d< double, 6 > > >
 
KRATOS_API_EXTERN template class KratosComponents< Variable< array_1d< double, 9 > > >
 
KRATOS_API_EXTERN template class KratosComponents< Variable< Quaternion< double > > >
 
KRATOS_API_EXTERN template class KratosComponents< Variable< Vector > >
 
KRATOS_API_EXTERN template class KratosComponents< Variable< Matrix > >
 
KRATOS_API_EXTERN template class KratosComponents< Variable< Flags > >
 
KRATOS_API_EXTERN template class KratosComponents< Flags >
 
KRATOS_API_EXTERN template class KratosComponents< DataCommunicator >
 
std::atomic_flag ThreadFixedSizeMemoryPoolLock = ATOMIC_FLAG_INIT
 
KRATOS_API_EXTERN template class KratosComponents< Modeler >
 
constexpr int normalComponentNumber = 0
 
constexpr int tangentialComponentNumber = 1
 
constexpr SizeType N_DIM_3D = 3
 
constexpr SizeType N_DIM_2D = 2
 
constexpr SizeType N_DIM_1D = 1
 
constexpr double TINY = 1.0e-60
 
constexpr double LARGE = 1.0e10
 
constexpr double PORE_PRESSURE_SIGN_FACTOR = 1.0
 
constexpr SizeType STRESS_TENSOR_SIZE_2D = 3
 
constexpr SizeType STRESS_TENSOR_SIZE_3D = 3
 
constexpr SizeType VOIGT_SIZE_3D = 6
 
constexpr SizeType VOIGT_SIZE_2D_PLANE_STRESS = 3
 
constexpr SizeType VOIGT_SIZE_2D_PLANE_STRAIN = 4
 
constexpr SizeType VOIGT_SIZE_2D_AXISYMMETRIC = 4
 
constexpr SizeType VOIGT_SIZE_2D_INTERFACE = 2
 
constexpr SizeType VOIGT_SIZE_3D_INTERFACE = 3
 
KRATOS_API_EXTERN template class KratosComponents< DenseLinearSolverFactoryType >
 
KRATOS_API_EXTERN template class KratosComponents< ComplexDenseLinearSolverFactoryType >
 
MMG5_pMesh mMmgMesh
 
MMG5_pSol mMmgMet
 The mesh data from MMG. More...
 
MMG5_pSol mMmgSol
 The metric variable for MMG. More...
 
MMG5_pSol mMmgDisp
 The solution variable for MMG. More...
 
PMMG_pParMesh mParMmgMesh
 
ModelPartmcalculation_model_part
 
ModelPartmtopographic_model_part
 
BinsObjectDynamic< Configure >::Pointer mpBinsObjectDynamic
 
KRATOS_API_EXTERN template class KratosComponents< TrilinosLinearSolverFactoryType >
 
Static Type Declarations
template<class TContainerPointType , class TContainerPointEmbeddedType >
const GeometryData BrepCurve< TContainerPointType, TContainerPointEmbeddedType >::msGeometryData & msGeometryDimension
 

Kratos Classes

enum class  BarycentricInterpolationType { LINE , TRIANGLE , TETRAHEDRA }
 
KRATOS_API_EXTERN template class GidIO< GidGaussPointsContainer, GidMeshContainer >
 
KRATOS_API_EXTERN template class KratosComponents< MasterSlaveConstraint >
 
constexpr static std::array< unsigned int, 4 > mNode0ID3D = {2, 0, 0, 0}
 
constexpr static std::array< unsigned int, 4 > mNode1ID3D = {3, 3, 1, 2}
 
constexpr static std::array< unsigned int, 4 > mNode2ID3D = {1, 2, 3, 1}
 
constexpr static std::array< unsigned int, 3 > mNode0ID2D = {1, 2, 0}
 
constexpr static std::array< unsigned int, 3 > mNode1ID2D = {2, 0, 1}
 
template<class TDataType >
std::istream & operator>> (std::istream &rIStream, GlobalPointer< TDataType > &rThis)
 input stream function More...
 
template<class TDataType >
std::ostream & operator<< (std::ostream &rOStream, const GlobalPointer< TDataType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream & operator>> (std::istream &rIStream, AMGCLSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream & operator<< (std::ostream &rOStream, const AMGCLSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 
template<class TSparseSpace , class TDenseSpace >
std::ostream & operator<< (std::ostream &rOStream, const Mapper< TSparseSpace, TDenseSpace > &rThis)
 output stream function More...
 
 KRATOS_CREATE_LOCAL_FLAG (ApplyConstantVectorValueProcess, X_COMPONENT_FIXED, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (ApplyConstantVectorValueProcess, Y_COMPONENT_FIXED, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (ApplyConstantVectorValueProcess, Z_COMPONENT_FIXED, 2)
 
template<std::size_t Dimension>
std::ostream & operator<< (std::ostream &rOut, RadiusPoint< Dimension > &rPoint)
 
template<std::size_t Dimension>
std::istream & operator>> (std::istream &rIn, RadiusPoint< Dimension > &rPoint)
 
template<class T >
std::ostream & operator<< (std::ostream &os, const IndirectScalar< T > &s)
 
void ModifyViscosityLikeEinstein (double &viscosity, const double solid_fraction)
 This class allows the interpolation between non-matching simplicial meshes in 2D and 3D with linear shape functions. it is designed for DEM-CFD coupling problems. More...
 
void ModifyViscosityLikeLiu (double &viscosity, const double solid_fraction)
 
template<std::size_t TDim, typename TBaseTypeOfSwimmingParticle >
std::ostream & operator<< (std::ostream &rOStream, const BinBasedDEMFluidCoupledMapping< TDim, TBaseTypeOfSwimmingParticle > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream & operator<< (std::ostream &rOStream, const Amesos2Solver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream & operator<< (std::ostream &rOStream, const AmesosSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream & operator<< (std::ostream &rOStream, const AmgclMPISolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream & operator<< (std::ostream &rOStream, const AztecSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 output stream function More...
 
template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream & operator<< (std::ostream &rOStream, const MultiLevelSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &rThis)
 output stream function More...
 

Type Definitions

typedef TUblasSparseSpace< doubleSparseSpaceType
 
typedef TUblasDenseSpace< doubleLocalSpaceType
 
typedef ExplicitBuilder< SparseSpaceType, LocalSpaceTypeExplicitBuilderType
 
using Matrix = Internals::Matrix< double, AMatrix::dynamic, AMatrix::dynamic >
 
using Vector = Internals::Matrix< double, AMatrix::dynamic, 1 >
 
template<typename TDataType >
using DenseMatrix = Internals::Matrix< TDataType, AMatrix::dynamic, AMatrix::dynamic >
 
template<typename TDataType >
using DenseVector = Internals::Matrix< TDataType, AMatrix::dynamic, 1 >
 
template<typename TDataType , std::size_t TSize>
using BoundedVector = Internals::Matrix< TDataType, TSize, 1 >
 
template<typename TDataType , std::size_t TSize1, std::size_t TSize2>
using BoundedMatrix = Internals::Matrix< TDataType, TSize1, TSize2 >
 
template<typename TExpressionType >
using vector_expression = AMatrix::MatrixExpression< TExpressionType, AMatrix::row_major_access >
 
template<typename TExpressionType >
using MatrixRow = AMatrix::MatrixRow< TExpressionType >
 
using ZeroMatrix = KratosZeroMatrix< double >
 
using ZeroVector = KratosZeroVector< double >
 
using IdentityMatrix = AMatrix::IdentityMatrix< double >
 
using ScalarMatrix = scalar_matrix< double >
 
typedef ModelPart::ElementsContainerType ElementsArrayType
 
typedef ModelPart::NodesContainerType NodesArrayType
 
typedef ModelPart::ConditionsContainerType ConditionsArrayType
 
using IndexType = std::size_t
 The definition of the index type. More...
 
using HashType = std::size_t
 The definition of the hash type. More...
 
using PointType = Point
 Geometric definitions. More...
 
using GeometryType = Geometry< Node >
 The definition of the geometry. More...
 
using IntegrationPointsType = typename GeometryType::IntegrationPointsArrayType
 
using SizeType = std::size_t
 The definition of the size type. More...
 
typedef DenseVector< std::complex< double > > ComplexVector
 
typedef unit_vector< std::complex< double > > ComplexUnitVector
 
typedef zero_vector< std::complex< double > > ComplexZeroVector
 
typedef scalar_vector< std::complex< double > > ComplexScalarVector
 
typedef mapped_vector< std::complex< double > > ComplexSparseVector
 
typedef compressed_vector< std::complex< double > > ComplexCompressedVector
 
typedef coordinate_vector< std::complex< double > > ComplexCoordinateVector
 
typedef vector_range< ComplexVectorComplexVectorRange
 
typedef vector_slice< ComplexVectorComplexVectorSlice
 
typedef DenseMatrix< std::complex< double > > ComplexMatrix
 
typedef identity_matrix< std::complex< double > > ComplexIdentityMatrix
 
typedef zero_matrix< std::complex< double > > ComplexZeroMatrix
 
typedef scalar_matrix< std::complex< double > > ComplexScalarMatrix
 
typedef triangular_matrix< std::complex< double > > ComplexTriangularMatrix
 
typedef symmetric_matrix< std::complex< double > > ComplexSymmetricMatrix
 
typedef hermitian_matrix< std::complex< double > > ComplexHermitianMatrix
 
typedef banded_matrix< std::complex< double > > ComplexBandedMatrix
 
typedef mapped_matrix< std::complex< double > > ComplexSparseMatrix
 
typedef compressed_matrix< std::complex< double > > ComplexCompressedMatrix
 
typedef coordinate_matrix< std::complex< double > > ComplexCoordinateMatrix
 
typedef matrix_row< ComplexMatrixComplexMatrixRow
 
typedef matrix_column< ComplexMatrixComplexMatrixColumn
 
typedef matrix_vector_range< ComplexMatrixComplexMatrixVectorRange
 
typedef matrix_vector_slice< ComplexMatrixComplexMatrixVectorSlice
 
typedef matrix_range< ComplexMatrixComplexMatrixRange
 
typedef matrix_slice< ComplexMatrixComplexMatrixSlice
 
typedef unit_vector< doubleUnitVector
 
typedef scalar_vector< doubleScalarVector
 
typedef mapped_vector< doubleSparseVector
 
typedef compressed_vector< doubleCompressedVector
 
typedef coordinate_vector< doubleCoordinateVector
 
typedef vector_range< VectorVectorRange
 
typedef vector_slice< VectorVectorSlice
 
typedef triangular_matrix< doubleTriangularMatrix
 
typedef symmetric_matrix< doubleSymmetricMatrix
 
typedef hermitian_matrix< doubleHermitianMatrix
 
typedef banded_matrix< doubleBandedMatrix
 
typedef mapped_matrix< doubleSparseMatrix
 
typedef coordinate_matrix< doubleCoordinateMatrix
 
typedef matrix_column< MatrixMatrixColumn
 
typedef matrix_vector_range< MatrixMatrixVectorRange
 
typedef matrix_vector_slice< MatrixMatrixVectorSlice
 
typedef matrix_range< MatrixMatrixRange
 
typedef matrix_slice< MatrixMatrixSlice
 
typedef boost::numeric::ublas::compressed_matrix< doubleCompressedMatrix
 
typedef ModelPart::NodesContainerType NodesContainerType
 
typedef ModelPart::ConditionsContainerType ConditionsContainerType
 
using NodeType = Node
 The definition of the node. More...
 
template<class TSparseSpace , class TDenseSpace >
using ExplicitSolvingStrategyRungeKutta4 = ExplicitSolvingStrategyRungeKutta< TSparseSpace, TDenseSpace, ButcherTableauRK4 >
 
template<class TSparseSpace , class TDenseSpace >
using ExplicitSolvingStrategyRungeKutta3TVD = ExplicitSolvingStrategyRungeKutta< TSparseSpace, TDenseSpace, ButcherTableauRK3TVD >
 
template<class TSparseSpace , class TDenseSpace >
using ExplicitSolvingStrategyRungeKutta2 = ExplicitSolvingStrategyRungeKutta< TSparseSpace, TDenseSpace, ButcherTableauMidPointMethod >
 
template<class TSparseSpace , class TDenseSpace >
using ExplicitSolvingStrategyRungeKutta1 = ExplicitSolvingStrategyRungeKutta< TSparseSpace, TDenseSpace, ButcherTableauForwardEuler >
 
typedef array_1d< double, 3 > Vector3
 
template<class TDataType >
using TKratosSmpSparseSpace = KratosSpace< TDataType, CsrMatrix< TDataType, IndexType >, SystemVector< TDataType, IndexType > >
 
template<class TDataType >
using TKratosSmpDenseSpace = KratosSpace< TDataType, DenseMatrix< TDataType >, DenseVector< TDataType > >
 
template<class TDataType >
using TUblasSparseSpace = UblasSpace< TDataType, boost::numeric::ublas::compressed_matrix< TDataType >, boost::numeric::ublas::vector< TDataType > >
 
template<class TDataType >
using TUblasDenseSpace = UblasSpace< TDataType, DenseMatrix< TDataType >, DenseVector< TDataType > >
 
typedef Element ElementType
 
typedef Condition ConditionType
 
using GeometryPointType = Geometry< PointType >
 
using IntegrationMethod = GeometryData::IntegrationMethod
 Type definition for integration methods. More...
 
typedef IntegrationPoint< 2 > IntegrationPointType
 
typedef TableStream TableStreamType
 
typedef FrictionLaw::Pointer FrictionLawPointerType
 
typedef ModelPart::ElementsContainerType ElementsContainerType
 
typedef GlobalPointersVector< NodeNodeWeakPtrVectorType
 
typedef GlobalPointersVector< ElementElementWeakPtrVectorType
 
typedef GlobalPointersVector< ConditionConditionWeakPtrVectorType
 
typedef Node::WeakPointer NodeWeakPtrType
 
typedef Element::WeakPointer ElementWeakPtrType
 
typedef Condition::WeakPointer ConditionWeakPtrType
 
typedef GeometryType::PointsArrayType PointsArrayType
 
typedef ConditionsContainerType::iterator ConditionIterator
 
typedef ConditionsContainerType::const_iterator ConditionConstantIterator
 
typedef array_1d< double, 6 > Vector6
 
typedef PointerVectorSet< Condition, IndexedObjectConditionContainerType
 
using hashmap = std::unordered_multimap< DenseVector< int >, std::vector< Condition::Pointer >, KeyHasherRange< DenseVector< int > >, KeyComparorRange< DenseVector< int > >>
 
typedef std::vector< IndexTypeIndexVectorType
 Index vector. More...
 
typedef PointType::Pointer PointTypePointer
 
typedef std::vector< PointTypePointerPointVector
 
typedef PointVector::iterator PointIterator
 
typedef std::vector< doubleDistanceVector
 
typedef DistanceVector::iterator DistanceIterator
 
typedef array_1d< double, 3 > VectorType
 
typedef Variable< VectorTypeVariableVectorType
 
typedef Variable< doubleVariableScalarType
 
typedef Variable< doubleVariableComponentType
 
typedef TimeIntegrationMethodsContainer< VariableVectorType, doubleVectorTimeIntegrationContainerType
 
typedef VectorTimeIntegrationContainerType::Pointer VectorTimeIntegrationContainerPointerType
 
typedef TimeIntegrationMethodsContainer< VariableScalarType, doubleScalarTimeIntegrationContainerType
 
typedef ScalarTimeIntegrationContainerType::Pointer ScalarTimeIntegrationContainerPointerType
 
typedef TimeIntegrationMethodsContainer< VariableComponentType, doubleComponentTimeIntegrationContainerType
 
typedef ComponentTimeIntegrationContainerType::Pointer ComponentTimeIntegrationContainerPointerType
 
typedef TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector > TrilinosSparseSpaceType
 
static ExplicitBuilderType msExplicitBuilder
 
template<typename T >
T & noalias (T &TheMatrix)
 
template<typename T >
AMatrix::TransposeMatrix< const T > trans (const T &TheMatrix)
 
template<typename T >
AMatrix::TransposeMatrix< T > trans (T &TheMatrix)
 
template<typename TExpression1Type , typename TExpression2Type , std::size_t TCategory1, std::size_t TCategory2>
AMatrix::MatrixProductExpression< TExpression1Type, TExpression2Type > prod (AMatrix::MatrixExpression< TExpression1Type, TCategory1 > const &First, AMatrix::MatrixExpression< TExpression2Type, TCategory2 > const &Second)
 
template<typename TExpression1Type , typename TExpression2Type , std::size_t TCategory1, std::size_t TCategory2>
AMatrix::VectorOuterProductExpression< TExpression1Type, TExpression2Type > outer_prod (AMatrix::MatrixExpression< TExpression1Type, TCategory1 > const &First, AMatrix::MatrixExpression< TExpression2Type, TCategory2 > const &Second)
 
template<typename TExpression1Type , typename TExpression2Type , std::size_t TCategory1, std::size_t TCategory2>
TExpression1Type::data_type inner_prod (AMatrix::MatrixExpression< TExpression1Type, TCategory1 > const &First, AMatrix::MatrixExpression< TExpression2Type, TCategory2 > const &Second)
 
template<typename TExpressionType , std::size_t TCategory>
TExpressionType::data_type norm_1 (AMatrix::MatrixExpression< TExpressionType, TCategory > const &TheExpression)
 
template<typename TExpressionType , std::size_t TCategory>
TExpressionType::data_type norm_2 (AMatrix::MatrixExpression< TExpressionType, TCategory > const &TheExpression)
 
template<typename TExpressionType , std::size_t TCategory>
AMatrix::MatrixColumn< const TExpressionType > column (AMatrix::MatrixExpression< TExpressionType, TCategory > const &TheExpression, std::size_t ColumnIndex)
 
template<typename TExpressionType , std::size_t TCategory>
AMatrix::MatrixColumn< TExpressionType > column (AMatrix::MatrixExpression< TExpressionType, TCategory > &TheExpression, std::size_t ColumnIndex)
 
template<typename TExpressionType , std::size_t TCategory>
AMatrix::MatrixRow< const TExpressionType > row (AMatrix::MatrixExpression< TExpressionType, TCategory > const &TheExpression, std::size_t RowIndex)
 
template<typename TExpressionType , std::size_t TCategory>
AMatrix::MatrixRow< TExpressionType > row (AMatrix::MatrixExpression< TExpressionType, TCategory > &TheExpression, std::size_t RowIndex)
 
template<typename TExpressionType , std::size_t TCategory>
AMatrix::SubVector< const TExpressionType > subrange (AMatrix::MatrixExpression< TExpressionType, TCategory > const &TheExpression, std::size_t From, std::size_t To)
 
template<typename TExpressionType , std::size_t TCategory>
AMatrix::SubVector< TExpressionType > subrange (AMatrix::MatrixExpression< TExpressionType, TCategory > &TheExpression, std::size_t From, std::size_t To)
 
template<typename TExpressionType , std::size_t TCategory>
TExpressionType::data_type sum (AMatrix::MatrixExpression< TExpressionType, TCategory > const &TheExpression)
 
template<typename TExpressionType , std::size_t TCategory>
TExpressionType::data_type norm_frobenius (AMatrix::MatrixExpression< TExpressionType, TCategory > const &TheExpression)
 
 KRATOS_CREATE_LOCAL_FLAG (SolverLocalFlags, INITIALIZED, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (SolverLocalFlags, CONVERGED, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (SolverLocalFlags, DOFS_INITIALIZED, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (SolverLocalFlags, ELEMENTS_INITIALIZED, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (SolverLocalFlags, CONDITIONS_INITIALIZED, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (SolverLocalFlags, ADAPTIVE_SOLUTION, 5)
 
 KRATOS_CREATE_LOCAL_FLAG (SolverLocalFlags, MOVE_MESH, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (SolverLocalFlags, UPDATE_VARIABLES, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (SolverLocalFlags, REFORM_DOFS, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (SolverLocalFlags, INCREMENTAL_SOLUTION, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (SolverLocalFlags, COMPUTE_REACTIONS, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (SolverLocalFlags, CONSTANT_SYSTEM_MATRIX, 5)
 
 KRATOS_CREATE_LOCAL_FLAG (SolverLocalFlags, RAYLEIGH_DAMPING, 6)
 
 KRATOS_CREATE_LOCAL_FLAG (SolverLocalFlags, IMPLEX, 7)
 
 KRATOS_CREATE_LOCAL_FLAG (CriterionLocalFlags, INITIALIZED, 0)
 
 KRATOS_CREATE_LOCAL_FLAG (CriterionLocalFlags, INCREMENTAL, 1)
 
 KRATOS_CREATE_LOCAL_FLAG (CriterionLocalFlags, CONVERGED, 2)
 
 KRATOS_CREATE_LOCAL_FLAG (CriterionLocalFlags, AND, 3)
 
 KRATOS_CREATE_LOCAL_FLAG (CriterionLocalFlags, OR, 4)
 
 KRATOS_CREATE_LOCAL_FLAG (CriterionLocalFlags, UPDATE_RHS, 5)
 
 KRATOS_CREATE_LOCAL_FLAG (CriterionLocalFlags, SUPPLIED_DOF, 6)
 
 KRATOS_CREATE_LOCAL_FLAG (TimeIntegrationLocalFlags, PREDICT_PRIMARY_VARIABLE, 0)
 

Functions

TABLE_NUMBER_ANGULAR_VELOCITY TABLE_NUMBER_MOMENT I33 BEAM_INERTIA_ROT_UNIT_LENGHT_Y KRATOS_DEFINE_APPLICATION_VARIABLE(DEM_APPLICATION, double, BEAM_INERTIA_ROT_UNIT_LENGHT_Z) typedef std double
 
REACTION_CHECK_STIFFNESS_FACTOR int
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL bool
 
template<class TClassType >
void HashCombine (HashType &Seed, const TClassType &Value)
 This method creates an "unique" hash for the input value. More...
 
template<class TClassType >
HashType HashRange (TClassType First, TClassType Last)
 This method combines hash until it reaches the last class in order to obtain a corresponding seed. More...
 
void AMGCLSolve (int block_size, TUblasSparseSpace< double >::MatrixType &rA, TUblasSparseSpace< double >::VectorType &rX, TUblasSparseSpace< double >::VectorType &rB, TUblasSparseSpace< double >::IndexType &rIterationNumber, double &rResidual, boost::property_tree::ptree amgclParams, int verbosity_level, bool use_gpgpu)
 This function solves with Ublas Matrix type. More...
 
std::istream & operator>> (std::istream &rIStream, IndexedPoint &rThis)
 input stream function More...
 
std::ostream & operator<< (std::ostream &rOStream, const IndexedPoint &rThis)
 output stream function More...
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CONSTITUTIVE_LAWS_APPLICATION, double, PREVIOUS_CYCLE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CONSTITUTIVE_LAWS_APPLICATION, bool, ADVANCE_STRATEGY_APPLIED)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CONSTITUTIVE_LAWS_APPLICATION, bool, SYMMETRIZE_TANGENT_OPERATOR)
 
 KRATOS_DEFINE_SYMMETRIC_3D_TENSOR_APPLICATION_VARIABLE_WITH_COMPONENTS (CONSTITUTIVE_LAWS_APPLICATION, ISOTROPIC_ANISOTROPIC_YIELD_RATIO)
 
 KRATOS_DEFINE_SYMMETRIC_3D_TENSOR_APPLICATION_VARIABLE_WITH_COMPONENTS (CONSTITUTIVE_LAWS_APPLICATION, ORTHOTROPIC_ELASTIC_CONSTANTS)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CONSTITUTIVE_LAWS_APPLICATION, double, SERIAL_PARALLEL_EQUILIBRIUM_TOLERANCE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CONSTITUTIVE_LAWS_APPLICATION, double, PLASTIC_DAMAGE_PROPORTION)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (CONTACT_STRUCTURAL_MECHANICS_APPLICATION, MasterSlaveConstraint::Pointer, CONSTRAINT_POINTER) KRATOS_DEFINE_APPLICATION_VARIABLE(CONTACT_STRUCTURAL_MECHANICS_APPLICATION
 
REACTION_CHECK_STIFFNESS_FACTOR KRATOS_DEFINE_APPLICATION_VARIABLE (CONTACT_STRUCTURAL_MECHANICS_APPLICATION, bool, CONSIDER_TESSELLATION) KRATOS_DEFINE_APPLICATION_VARIABLE(CONTACT_STRUCTURAL_MECHANICS_APPLICATION
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION KRATOS_DEFINE_APPLICATION_VARIABLE (CONTACT_STRUCTURAL_MECHANICS_APPLICATION, int, INTEGRATION_ORDER_CONTACT) KRATOS_DEFINE_APPLICATION_VARIABLE(CONTACT_STRUCTURAL_MECHANICS_APPLICATION
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD KRATOS_DEFINE_APPLICATION_VARIABLE (CONTACT_STRUCTURAL_MECHANICS_APPLICATION, double, ZERO_TOLERANCE_FACTOR) KRATOS_DEFINE_APPLICATION_VARIABLE(CONTACT_STRUCTURAL_MECHANICS_APPLICATION
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR KRATOS_DEFINE_APPLICATION_VARIABLE (CONTACT_STRUCTURAL_MECHANICS_APPLICATION, double, SLIP_THRESHOLD) KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS(CONTACT_STRUCTURAL_MECHANICS_APPLICATION
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (CONTACT_STRUCTURAL_MECHANICS_APPLICATION, DELTA_COORDINATES) KRATOS_DEFINE_APPLICATION_VARIABLE(CONTACT_STRUCTURAL_MECHANICS_APPLICATION
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (CONTACT_STRUCTURAL_MECHANICS_APPLICATION, TANGENT_SLIP) KRATOS_DEFINE_APPLICATION_VARIABLE(CONTACT_STRUCTURAL_MECHANICS_APPLICATION
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (CONTACT_STRUCTURAL_MECHANICS_APPLICATION, WEIGHTED_SLIP) KRATOS_DEFINE_APPLICATION_VARIABLE(CONTACT_STRUCTURAL_MECHANICS_APPLICATION
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (CONTACT_STRUCTURAL_MECHANICS_APPLICATION, WEIGHTED_VECTOR_RESIDUAL) KRATOS_DEFINE_APPLICATION_VARIABLE(CONTACT_STRUCTURAL_MECHANICS_APPLICATION
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED KRATOS_DEFINE_APPLICATION_VARIABLE (CONTACT_STRUCTURAL_MECHANICS_APPLICATION, bool, ACTIVE_SET_CONVERGED) KRATOS_DEFINE_APPLICATION_VARIABLE(CONTACT_STRUCTURAL_MECHANICS_APPLICATION
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED KRATOS_DEFINE_APPLICATION_VARIABLE (CONTACT_STRUCTURAL_MECHANICS_APPLICATION, double, OPERATOR_THRESHOLD) KRATOS_DEFINE_APPLICATION_VARIABLE(CONTACT_STRUCTURAL_MECHANICS_APPLICATION
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT KRATOS_DEFINE_APPLICATION_VARIABLE (CONTACT_STRUCTURAL_MECHANICS_APPLICATION, double, DYNAMIC_FACTOR) KRATOS_DEFINE_APPLICATION_VARIABLE(CONTACT_STRUCTURAL_MECHANICS_APPLICATION
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT LAGRANGE_MULTIPLIER_CONTACT_PRESSURE KRATOS_DEFINE_APPLICATION_VARIABLE (CONTACT_STRUCTURAL_MECHANICS_APPLICATION, double, AUGMENTED_NORMAL_CONTACT_PRESSURE) KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS(CONTACT_STRUCTURAL_MECHANICS_APPLICATION
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT LAGRANGE_MULTIPLIER_CONTACT_PRESSURE AUGMENTED_TANGENT_CONTACT_PRESSURE KRATOS_DEFINE_APPLICATION_VARIABLE (CONTACT_STRUCTURAL_MECHANICS_APPLICATION, int, CONSIDER_NORMAL_VARIATION) KRATOS_DEFINE_APPLICATION_VARIABLE(CONTACT_STRUCTURAL_MECHANICS_APPLICATION
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT LAGRANGE_MULTIPLIER_CONTACT_PRESSURE AUGMENTED_TANGENT_CONTACT_PRESSURE ADAPT_PENALTY KRATOS_DEFINE_APPLICATION_VARIABLE (CONTACT_STRUCTURAL_MECHANICS_APPLICATION, double, MAX_GAP_FACTOR) KRATOS_DEFINE_APPLICATION_VARIABLE(CONTACT_STRUCTURAL_MECHANICS_APPLICATION
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT LAGRANGE_MULTIPLIER_CONTACT_PRESSURE AUGMENTED_TANGENT_CONTACT_PRESSURE ADAPT_PENALTY TYING_VARIABLE KRATOS_DEFINE_APPLICATION_VARIABLE (CONTACT_STRUCTURAL_MECHANICS_APPLICATION, Element::Pointer, PARENT_ELEMENT) KRATOS_DEFINE_APPLICATION_VARIABLE(CONTACT_STRUCTURAL_MECHANICS_APPLICATION
 
REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT LAGRANGE_MULTIPLIER_CONTACT_PRESSURE AUGMENTED_TANGENT_CONTACT_PRESSURE ADAPT_PENALTY TYING_VARIABLE MAX_GAP_THRESHOLD KRATOS_DEFINE_APPLICATION_VARIABLE (CONTACT_STRUCTURAL_MECHANICS_APPLICATION, FrictionalLaw::Pointer, FRICTIONAL_LAW) KRATOS_DEFINE_APPLICATION_VARIABLE(CONTACT_STRUCTURAL_MECHANICS_APPLICATION
 
GeometryType::Pointer GetGeometryFromModelPart (const ModelPart &rModelPart)
 This method retrieves the first geometry from a model part. More...
 
int DeterminePartitionWithEntities (const ModelPart &rModelPart)
 This method determines the partition where the model part has at least one entity. More...
 
unsigned int DetermineModelPartMaximumLocalDimension (ModelPart &rModelPart)
 This method determines maximum local space dimension of a ModelPart. More...
 
ModelPartDetermine2DModelPart (ModelPart &rFirstModelPart, ModelPart &rSecondModelPart)
 This method determines the 2D model part. More...
 
ModelPartDetermine3DModelPart (ModelPart &rFirstModelPart, ModelPart &rSecondModelPart)
 This method determines the 3D model part. More...
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (MESHING_APPLICATION, double, AVERAGE_NODAL_ERROR)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (MESHING_APPLICATION, double, ANISOTROPIC_RATIO)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (MESHING_APPLICATION, Vector3, AUXILIAR_GRADIENT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (MESHING_APPLICATION, Vector, AUXILIAR_HESSIAN)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (MESHING_APPLICATION, double, METRIC_SCALAR)
 
 KRATOS_DEFINE_SYMMETRIC_2D_TENSOR_APPLICATION_VARIABLE_WITH_COMPONENTS (MESHING_APPLICATION, METRIC_TENSOR_2D)
 
 KRATOS_DEFINE_SYMMETRIC_3D_TENSOR_APPLICATION_VARIABLE_WITH_COMPONENTS (MESHING_APPLICATION, METRIC_TENSOR_3D)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (MESHING_APPLICATION, int, NUMBER_OF_DIVISIONS)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, int, INTEGRATION_ORDER)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, double, PLASTIC_ALPHA)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, double, ALPHA_EAS)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, bool, CONSIDER_IMPLICIT_EAS_SPRISM_ELEMENT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, bool, CONSIDER_TOTAL_LAGRANGIAN_SPRISM_ELEMENT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, bool, PURE_EXPLICIT_RHS_COMPUTATION)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, bool, RESET_EQUATION_IDS)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, double, ANG_ROT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, bool, CONSIDER_QUADRATIC_SPRISM_ELEMENT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, Vector, HENCKY_STRAIN_VECTOR)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, Matrix, HENCKY_STRAIN_TENSOR)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, Matrix, REFERENCE_DEFORMATION_GRADIENT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, double, REFERENCE_DEFORMATION_GRADIENT_DETERMINANT)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, double, CROSS_AREA_SENSITIVITY)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (STRUCTURAL_MECHANICS_APPLICATION, POINT_LOAD_SENSITIVITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, double, I22_SENSITIVITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, double, I33_SENSITIVITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, double, THICKNESS_SENSITIVITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, double, YOUNG_MODULUS_SENSITIVITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, double, AREA_EFFECTIVE_Y_SENSITIVITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, double, AREA_EFFECTIVE_Z_SENSITIVITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, bool, IS_ADJOINT)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (STRUCTURAL_MECHANICS_APPLICATION, NODAL_DISPLACEMENT_STIFFNESS_SENSITIVITY)
 
 KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS (STRUCTURAL_MECHANICS_APPLICATION, NODAL_ROTATIONAL_STIFFNESS_SENSITIVITY)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, int, TRACED_STRESS_TYPE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, Matrix, STRESS_DISP_DERIV_ON_NODE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, Matrix, STRESS_DISP_DERIV_ON_GP)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, Matrix, STRESS_DESIGN_DERIVATIVE_ON_NODE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, Matrix, STRESS_DESIGN_DERIVATIVE_ON_GP)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, Vector, STRESS_ON_GP)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, Vector, STRESS_ON_NODE)
 
 KRATOS_DEFINE_APPLICATION_VARIABLE (STRUCTURAL_MECHANICS_APPLICATION, std::string, DESIGN_VARIABLE_NAME)
 

Detailed Description

REF: G. R. Cowper, GAUSSIAN QUADRATURE FORMULAS FOR TRIANGLES.

VARIABLES used:

                     WARNING! THIS FILE IS READ-ONLY

This file has been auto-generated by compressible_navier_stokes_symbolic_generator.py located in the symbolic_generation directories of the FluidDynamicsApplication

Any modifications to this file will be overwritten if and when that script is run again.

In order to do any lasting changes, modify the template used by the script: templates/compressible_navier_stokes_explicit_template_2D3N.cpp located in the symbolic_generation directories of the FluidDynamicsApplication.

In order to change the formulation you will have to modify the script itself.

                     WARNING! THIS FILE IS READ-ONLY

This file has been auto-generated by compressible_navier_stokes_symbolic_generator.py located in the symbolic_generation directories of the FluidDynamicsApplication

Any modifications to this file will be overwritten if and when that script is run again.

In order to do any lasting changes, modify the template used by the script: templates/compressible_navier_stokes_explicit_template_2D4N.cpp located in the symbolic_generation directories of the FluidDynamicsApplication.

In order to change the formulation you will have to modify the script itself.

                     WARNING! THIS FILE IS READ-ONLY

This file has been auto-generated by compressible_navier_stokes_symbolic_generator.py located in the symbolic_generation directories of the FluidDynamicsApplication

Any modifications to this file will be overwritten if and when that script is run again.

In order to do any lasting changes, modify the template used by the script: templates/compressible_navier_stokes_explicit_template_3D4N.cpp located in the symbolic_generation directories of the FluidDynamicsApplication.

In order to change the formulation you will have to modify the script itself.

Description: Isogeometric hierarchic Reissner-Mindlin shell element parameterized by 5 parameters (5p) The 5 parameters: three translations (u,v,w) and two parameters (w_1,w_2) building the hierarchic shear difference vector The 5p element takes shear deformations into account according to the Reissner-Mindlin shell theory. The hierarchy means that the shell element builds on top of the Kirchhoff-Love shell element (iga_shell_3p_element) in the sense that the existing equations remain unchanged and additional terms are added.

Implementation: So far there are no new parameters defined, instead ROTATION_X = w_1 and ROTATION_Y = w_2.

Attention: In the last version of this element, there were still open questions and problems. For further information please do not hesitate to contact the author.

WARNING it is needed compute he neirgbourg

Typedef Documentation

◆ AnalyticFace

◆ AnalyticParticle

◆ BandedMatrix

typedef banded_matrix<double> Kratos::BandedMatrix

◆ BaseSchemeType

◆ Boost2DPointType

typedef boost::geometry::model::point<double, 2, boost::geometry::cs::cartesian> Kratos::Boost2DPointType

◆ Boost2DPolygonType

typedef boost::geometry::model::polygon<Boost2DPointType> Kratos::Boost2DPolygonType

◆ BoundedMatrix

template<typename TDataType , std::size_t TSize1, std::size_t TSize2>
using Kratos::BoundedMatrix = typedef boost::numeric::ublas::bounded_matrix<TDataType, TSize1, TSize2>

◆ BoundedVector

template<typename TDataType , std::size_t TSize>
using Kratos::BoundedVector = typedef boost::numeric::ublas::bounded_vector<TDataType, TSize>

◆ ComplexBandedMatrix

typedef banded_matrix<std::complex<double> > Kratos::ComplexBandedMatrix

◆ ComplexCompressedMatrix

typedef compressed_matrix<std::complex<double> > Kratos::ComplexCompressedMatrix

◆ ComplexCompressedVector

typedef compressed_vector<std::complex<double> > Kratos::ComplexCompressedVector

◆ ComplexCoordinateMatrix

typedef coordinate_matrix<std::complex<double> > Kratos::ComplexCoordinateMatrix

◆ ComplexCoordinateVector

typedef coordinate_vector<std::complex<double> > Kratos::ComplexCoordinateVector

◆ ComplexDenseLinearSolverFactoryType

◆ ComplexDenseSpace

using Kratos::ComplexDenseSpace = typedef UblasSpace<std::complex<double>, DenseMatrix<std::complex<double> >, DenseVector<std::complex<double> >>

◆ ComplexHermitianMatrix

typedef hermitian_matrix<std::complex<double> > Kratos::ComplexHermitianMatrix

◆ ComplexIdentityMatrix

typedef identity_matrix<std::complex<double> > Kratos::ComplexIdentityMatrix

◆ ComplexLinearSolverFactoryType

◆ ComplexLocalSparseSpaceType

◆ ComplexMatrix

typedef DenseMatrix<std::complex<double> > Kratos::ComplexMatrix

◆ ComplexMatrixColumn

◆ ComplexMatrixRange

◆ ComplexMatrixRow

◆ ComplexMatrixSlice

◆ ComplexMatrixVectorRange

typedef matrix_vector_range<ComplexMatrix> Kratos::ComplexMatrixVectorRange

◆ ComplexMatrixVectorSlice

typedef matrix_vector_slice<ComplexMatrix> Kratos::ComplexMatrixVectorSlice

◆ ComplexScalarMatrix

◆ ComplexScalarVector

typedef scalar_vector<std::complex<double> > Kratos::ComplexScalarVector

◆ ComplexSparseMatrix

typedef mapped_matrix<std::complex<double> > Kratos::ComplexSparseMatrix

◆ ComplexSparseSpace

using Kratos::ComplexSparseSpace = typedef UblasSpace<std::complex<double>, boost::numeric::ublas::compressed_matrix<std::complex<double> >, boost::numeric::ublas::vector<std::complex<double> >>

◆ ComplexSparseSpaceType

◆ ComplexSparseVector

typedef mapped_vector<std::complex<double> > Kratos::ComplexSparseVector

◆ ComplexSymmetricMatrix

typedef symmetric_matrix<std::complex<double> > Kratos::ComplexSymmetricMatrix

◆ ComplexTriangularMatrix

typedef triangular_matrix<std::complex<double> > Kratos::ComplexTriangularMatrix

◆ ComplexUnitVector

typedef unit_vector<std::complex<double> > Kratos::ComplexUnitVector

◆ ComplexVector

typedef DenseVector<std::complex<double> > Kratos::ComplexVector

◆ ComplexVectorRange

◆ ComplexVectorSlice

◆ ComplexZeroMatrix

typedef zero_matrix<std::complex<double> > Kratos::ComplexZeroMatrix

◆ ComplexZeroVector

typedef zero_vector<std::complex<double> > Kratos::ComplexZeroVector

◆ ComponentTimeIntegrationContainerPointerType

typedef ComponentTimeIntegrationContainerType::Pointer Kratos::ComponentTimeIntegrationContainerPointerType

◆ ComponentTimeIntegrationContainerType

◆ CompressedMatrix

typedef boost::numeric::ublas::compressed_matrix<double> Kratos::CompressedMatrix

◆ CompressedVector

typedef compressed_vector<double> Kratos::CompressedVector

◆ CompressibleNavierStokesExplicitSolvingStrategyForwardEuler

◆ CompressibleNavierStokesExplicitSolvingStrategyRungeKutta3TVD

template<class TSparseSpace , class TDenseSpace >
using Kratos::CompressibleNavierStokesExplicitSolvingStrategyRungeKutta3TVD = typedef CompressibleNavierStokesExplicitSolvingStrategyRungeKutta<TSparseSpace, TDenseSpace, ButcherTableauRK3TVD>

◆ CompressibleNavierStokesExplicitSolvingStrategyRungeKutta4

template<class TSparseSpace , class TDenseSpace >
using Kratos::CompressibleNavierStokesExplicitSolvingStrategyRungeKutta4 = typedef CompressibleNavierStokesExplicitSolvingStrategyRungeKutta<TSparseSpace, TDenseSpace, ButcherTableauRK4>

◆ ConditionConstantIterator

◆ ConditionContainerType

◆ ConditionIterator

◆ ConditionsArrayType

◆ ConditionsContainerType

◆ ConditionsIteratorType

◆ ConditionType

◆ ConditionWeakPtrType

typedef Condition::WeakPointer Kratos::ConditionWeakPtrType

◆ ConditionWeakPtrVectorType

◆ CoordinateMatrix

typedef coordinate_matrix<double> Kratos::CoordinateMatrix

◆ CoordinateVector

typedef coordinate_vector<double> Kratos::CoordinateVector

◆ DenseLinearSolverFactoryType

◆ DenseMatrix

template<typename TDataType >
using Kratos::DenseMatrix = typedef boost::numeric::ublas::matrix<TDataType>

◆ DenseSpaceType

◆ DenseVector

template<typename TDataType >
using Kratos::DenseVector = typedef boost::numeric::ublas::vector<TDataType>

◆ DiscreteParticleConfigure3D

◆ DistanceIterator

typedef DistanceVector::iterator Kratos::DistanceIterator

◆ DistanceVector

typedef std::vector<double> Kratos::DistanceVector

◆ EigenDynamicMatrix

template<typename _Scalar >
using Kratos::EigenDynamicMatrix = typedef Eigen::Matrix<_Scalar, Eigen::Dynamic, Eigen::Dynamic, Eigen::RowMajor>

◆ EigenDynamicVector

template<typename _Scalar >
using Kratos::EigenDynamicVector = typedef Eigen::Matrix<_Scalar, Eigen::Dynamic, 1>

◆ EigenSparseMatrix

template<typename _Scalar >
using Kratos::EigenSparseMatrix = typedef Eigen::SparseMatrix<_Scalar, Eigen::RowMajor, int>

◆ ElementIterator

typedef MeshType::ElementIterator Kratos::ElementIterator

◆ ElementIteratorType

◆ ElementsArrayType

Type definitions

◆ ElementsContainerType

◆ ElementsIteratorType

◆ ElementType

◆ ElementWeakPtrType

typedef Element::WeakPointer Kratos::ElementWeakPtrType

◆ ExplicitBuilderType

◆ ExplicitSolvingStrategyRungeKutta1

template<class TSparseSpace , class TDenseSpace >
using Kratos::ExplicitSolvingStrategyRungeKutta1 = typedef ExplicitSolvingStrategyRungeKutta<TSparseSpace, TDenseSpace, ButcherTableauForwardEuler>

◆ ExplicitSolvingStrategyRungeKutta2

template<class TSparseSpace , class TDenseSpace >
using Kratos::ExplicitSolvingStrategyRungeKutta2 = typedef ExplicitSolvingStrategyRungeKutta<TSparseSpace, TDenseSpace, ButcherTableauMidPointMethod>

◆ ExplicitSolvingStrategyRungeKutta3TVD

template<class TSparseSpace , class TDenseSpace >
using Kratos::ExplicitSolvingStrategyRungeKutta3TVD = typedef ExplicitSolvingStrategyRungeKutta<TSparseSpace, TDenseSpace, ButcherTableauRK3TVD>

◆ ExplicitSolvingStrategyRungeKutta4

template<class TSparseSpace , class TDenseSpace >
using Kratos::ExplicitSolvingStrategyRungeKutta4 = typedef ExplicitSolvingStrategyRungeKutta<TSparseSpace, TDenseSpace, ButcherTableauRK4>

◆ FluidParticlePointerVector

◆ FrictionLawPointerType

typedef FrictionLaw::Pointer Kratos::FrictionLawPointerType

◆ GeometryNodePointerType

◆ GeometryPointType

◆ GeometryType

The definition of the geometry.

Definition of the geometry type with given NodeType.

◆ hashmap

using Kratos::hashmap = typedef std::unordered_multimap<DenseVector<int>, std::vector<Condition::Pointer>, KeyHasherRange<DenseVector<int> >, KeyComparorRange<DenseVector<int> >>

◆ HermitianMatrix

typedef hermitian_matrix<double> Kratos::HermitianMatrix

◆ IdentityMatrix

typedef identity_matrix< double > Kratos::IdentityMatrix

◆ IndexVectorType

typedef std::vector< IndexType > Kratos::IndexVectorType

Index vector.

◆ IntegrationMethod

Type definition for integration methods.

◆ IntegrationMethodType

◆ IntegrationPointsType

◆ IntegrationPointType

◆ KratosGeometryFamily

◆ LinearSolverFactoryType

◆ LinearSolverType

◆ LocalSpaceType

◆ LocalSparseSpaceType

◆ Matrix

typedef matrix< double > Kratos::Matrix

◆ MatrixColumn

typedef matrix_column<Matrix> Kratos::MatrixColumn

◆ MatrixRange

typedef matrix_range<Matrix> Kratos::MatrixRange

◆ MatrixRow

template<typename TExpressionType >
using Kratos::MatrixRow = typedef matrix_row<TExpressionType>

◆ MatrixSlice

typedef matrix_slice<Matrix> Kratos::MatrixSlice

◆ MatrixVectorRange

typedef matrix_vector_range<Matrix> Kratos::MatrixVectorRange

◆ MatrixVectorSlice

typedef matrix_vector_slice<Matrix> Kratos::MatrixVectorSlice

◆ MeshesContainerType

◆ MeshType

◆ NodeIteratorType

typedef ModelPart::NodesContainerType::iterator Kratos::NodeIteratorType

◆ NodesArrayType

◆ NodesContainerType

◆ NodeType

The definition of the node.

we define the node type

Definition of node type.

◆ NodeWeakPtrType

typedef Node::WeakPointer Kratos::NodeWeakPtrType

◆ NodeWeakPtrVectorType

◆ ParticlePointerVector

◆ pF_GetParamCount

typedef void(* Kratos::pF_GetParamCount) (int *, int *)

◆ pF_GetStateVarCount

typedef void(* Kratos::pF_GetStateVarCount) (int *, int *)

◆ pF_UMATMod

typedef void(* Kratos::pF_UMATMod) (double *STRESS, double *STATEV, double **DDSDDE, double *SSE, double *SPD, double *SCD, double *rpl, double *ddsddt, double *drplde, double *drpldt, double *stran, double *dstran, double *time, double *dtime, double *temp, double *dtemp, double *predef, double *dpred, char *materl, int *ndi, int *nshr, int *ntens, int *nstatv, const double *props, int *nprops, double *coords, double **drot, double *pnewdt, double *celent, double **dfgrd0, double **dfgrd1, int *noel, int *npt, double *kslay, double *kspt, int *kstep, int *kinc)

◆ pF_UserMod

typedef void(* Kratos::pF_UserMod) (int *, int *, int *, int *, int *, int *, int *, double *, double *, double *, double *, double *, const double *, double *, double *, double *, double *, double **, double *, double *, double *, double *, int *, int *, int *, int *, int *, int *, int *, int *, int *)

◆ PointIterator

typedef PointVector::iterator Kratos::PointIterator

◆ PointsArrayType

typedef ModelPart::MeshType::GeometryType::PointsArrayType Kratos::PointsArrayType

◆ PointType

Geometric definitions.

Type definitions for the tree.

◆ PointTypePointer

typedef PointType::Pointer Kratos::PointTypePointer

◆ PointVector

typedef std::vector<PointTypePointer> Kratos::PointVector

◆ PreconditionerFactoryType

◆ PropertiesContainerPointerType

typedef PropertiesContainerType::Pointer Kratos::PropertiesContainerPointerType

◆ PropertiesContainerType

◆ PropertiesType

◆ RealDenseSpace

◆ RealSparseSpace

using Kratos::RealSparseSpace = typedef UblasSpace<double, boost::numeric::ublas::compressed_matrix<double>, boost::numeric::ublas::vector<double> >

◆ ScalarMatrix

◆ ScalarTimeIntegrationContainerPointerType

typedef ScalarTimeIntegrationContainerType::Pointer Kratos::ScalarTimeIntegrationContainerPointerType

◆ ScalarTimeIntegrationContainerType

◆ ScalarVector

typedef scalar_vector<double> Kratos::ScalarVector

◆ shared_ptr

template<class T >
using Kratos::shared_ptr = typedef std::shared_ptr<T>

◆ SizeType

typedef std::size_t Kratos::SizeType

The definition of the size type.

Defining the integers.

Size definition.

Definition of the size type.

The size type definition.

The size definition.

The definition of the sizetype.

◆ SparseMatrix

typedef mapped_matrix<double> Kratos::SparseMatrix

◆ SparseSpaceType

typedef UblasSpace< double, CompressedMatrix, boost::numeric::ublas::vector< double > > Kratos::SparseSpaceType

◆ SparseVector

typedef mapped_vector<double> Kratos::SparseVector

◆ SymmetricMatrix

typedef symmetric_matrix<double> Kratos::SymmetricMatrix

◆ TableStreamType

◆ TKratosSmpDenseSpace

template<class TDataType >
using Kratos::TKratosSmpDenseSpace = typedef KratosSpace<TDataType, DenseMatrix<TDataType>, DenseVector<TDataType> >

◆ TKratosSmpSparseSpace

template<class TDataType >
using Kratos::TKratosSmpSparseSpace = typedef KratosSpace<TDataType, CsrMatrix<TDataType,IndexType>, SystemVector<TDataType,IndexType> >

◆ TriangularMatrix

typedef triangular_matrix<double> Kratos::TriangularMatrix

◆ TrilinosLinearSolverFactoryType

◆ TrilinosLocalSpaceType

◆ TUblasDenseSpace

template<class TDataType >
using Kratos::TUblasDenseSpace = typedef UblasSpace<TDataType, DenseMatrix<TDataType>, DenseVector<TDataType> >

◆ TUblasSparseSpace

template<class TDataType >
using Kratos::TUblasSparseSpace = typedef UblasSpace<TDataType, boost::numeric::ublas::compressed_matrix<TDataType>, boost::numeric::ublas::vector<TDataType> >

◆ unique_ptr

template<class T >
using Kratos::unique_ptr = typedef std::unique_ptr<T>

◆ UnitVector

typedef unit_vector<double> Kratos::UnitVector

◆ VariableComponentType

◆ VariableScalarType

◆ VariableVectorType

◆ Vector

TOPOGRAPHY RAIN CHEZY RELATIVE_DRY_HEIGHT Kratos::Vector

◆ Vector3

◆ Vector6

◆ vector_expression

template<typename TExpressionType >
using Kratos::vector_expression = typedef AMatrix::MatrixExpression<TExpressionType,AMatrix::row_major_access>

◆ VectorArray3Double

◆ VectorContainerType

◆ VectorRange

typedef vector_range<Vector> Kratos::VectorRange

◆ VectorSlice

typedef vector_slice<Vector> Kratos::VectorSlice

◆ VectorTimeIntegrationContainerPointerType

typedef VectorTimeIntegrationContainerType::Pointer Kratos::VectorTimeIntegrationContainerPointerType

◆ VectorTimeIntegrationContainerType

◆ VectorType

◆ weak_ptr

template<class T >
using Kratos::weak_ptr = typedef std::weak_ptr<T>

◆ ZeroMatrix

typedef zero_matrix< double > Kratos::ZeroMatrix

◆ ZeroVector

typedef zero_vector< double > Kratos::ZeroVector

Enumeration Type Documentation

◆ AMGCLCoarseningType

Enumerator
RUGE_STUBEN 
AGGREGATION 
SA 
SA_EMIN 

◆ AMGCLIterativeSolverType

Enumerator
LGMRES 
FGMRES 
GMRES 
BICGSTAB 
CG 
BICGSTAB_WITH_GMRES_FALLBACK 
BICGSTAB2 

◆ AMGCLSmoother

Enumerator
SPAI0 
SPAI1 
ILU0 
DAMPED_JACOBI 
GAUSS_SEIDEL 
CHEBYSHEV 

◆ AztecScalingType

Enumerator
NoScaling 
LeftScaling 
SymmetricScaling 

◆ BarycentricInterpolationType

Enumerator
LINE 
TRIANGLE 
TETRAHEDRA 

◆ Configuration

Enumerator
Initial 
Current 

◆ DiscretizationOption

This enums allows to differentiate the discretization options.

Enumerator
STANDARD 
LAGRANGIAN 
ISOSURFACE 

◆ FrameworkEulerLagrange

This enums allows to differentiate the working framework.

Enumerator
EULERIAN 
LAGRANGIAN 
ALE 

◆ FrictionalCase

An enumeration of the different cases of friction that can be used in the contact search process.

Enumerator
FRICTIONLESS 

Frictionless contact.

FRICTIONLESS_COMPONENTS 

Frictionless contact with components.

FRICTIONAL 

Frictional contact.

FRICTIONLESS_PENALTY 

Frictionless contact with penalty method.

FRICTIONAL_PENALTY 

Frictional contact with penalty method.

◆ indexDOF2DBeam

Enumerator
INDEX_2D_BEAM_X 
INDEX_2D_BEAM_Y 
INDEX_2D_BEAM_T 

◆ indexDOF3D

Enumerator
INDEX_X 
INDEX_Y 
INDEX_Z 

◆ indexStress2DAxisymmetric

Enumerator
INDEX_2D_AXI_SYMMETRIC_XX 
INDEX_2D_AXI_SYMMETRIC_YY 
INDEX_2D_AXI_SYMMETRIC_RR 
INDEX_2D_AXI_SYMMETRIC_XY 

◆ indexStress2DBeam

Enumerator
INDEX_2D_BEAM_XX 
INDEX_2D_BEAM_YY 
INDEX_2D_BEAM_XY 

◆ indexStress2DInterface

Enumerator
INDEX_2D_INTERFACE_XZ 
INDEX_2D_INTERFACE_ZZ 

◆ indexStress2DPlaneStrain

Enumerator
INDEX_2D_PLANE_STRAIN_XX 
INDEX_2D_PLANE_STRAIN_YY 
INDEX_2D_PLANE_STRAIN_ZZ 
INDEX_2D_PLANE_STRAIN_XY 

◆ indexStress2DPlaneStress

Enumerator
INDEX_2D_PLANE_STRESS_XX 
INDEX_2D_PLANE_STRESS_YY 
INDEX_2D_PLANE_STRESS_XY 

◆ indexStress3D

Enumerator
INDEX_3D_XX 
INDEX_3D_YY 
INDEX_3D_ZZ 
INDEX_3D_XY 
INDEX_3D_YZ 
INDEX_3D_XZ 

◆ indexStress3DInterface

Enumerator
INDEX_3D_INTERFACE_XZ 
INDEX_3D_INTERFACE_YZ 
INDEX_3D_INTERFACE_ZZ 

◆ indexThermalFlux

Enumerator

◆ MeshType

Enumerator
Local 
Ghost 
Interface 

◆ MMGLibrary

enum Kratos::MMGLibrary
strong

This enum defines the type of MMG libray used.

Enumerator
MMG2D 
MMG3D 
MMGS 

◆ MultiFileFlag

Enumerator
SingleFile 
MultipleFiles 

◆ NormalDerivativesComputation

An enumeration of the different options for normal derivatives computation.

Enumerator
NO_DERIVATIVES_COMPUTATION 

No computation of normal derivatives.

ELEMENTAL_DERIVATIVES 

Computation of normal derivatives at the element level.

NODAL_ELEMENTAL_DERIVATIVES 

Computation of normal derivatives at the node level.

NO_DERIVATIVES_COMPUTATION_WITH_NORMAL_UPDATE 

No computation of normal derivatives, but update of the normal vector.

◆ OBBHasIntersectionType

This enum defines the different types of checks that can be done for the HasIntersection:

Enumerator
Direct 
SeparatingAxisTheorem 

◆ PMMGLibrary

enum Kratos::PMMGLibrary
strong

This enum defines the type of PMMG libray used.

Enumerator
PMMG3D 

◆ PointBelongs

enum Kratos::PointBelongs
strong

This enum defines a "hash" used to identify in which combination of cuts the point is found when the mortar segmentation is performed.

Enumerator
Master 
Slave 

The point belongs to the master entity.

Intersection 

The point belongs to the slave entity.

◆ PointBelongsLine2D2N

Case for 2D line intersected with another 2D line.

Enumerator
SlaveLine2D2N0 
SlaveLine2D2N1 

The point belongs to the first slave node of a 2D line element.

MasterLine2D2N0 

The point belongs to the second slave node of a 2D line element.

MasterLine2D2N1 

The point belongs to the first master node of a 2D line element.

IntersectionLine2D2N 

The point belongs to the second master node of a 2D line element.

◆ PointBelongsQuadrilateral3D4N

Case for 3D quadrilateral intersected with another 3D quadrilateral.

Enumerator
SlaveQuadrilateral3D4N0 
SlaveQuadrilateral3D4N1 
SlaveQuadrilateral3D4N2 
SlaveQuadrilateral3D4N3 
MasterQuadrilateral3D4N0 
MasterQuadrilateral3D4N1 
MasterQuadrilateral3D4N2 
MasterQuadrilateral3D4N3 
IntersectionQuadrilateral3D4N 
IntersectionQuadrilateral3D4N0101 
IntersectionQuadrilateral3D4N1001 
IntersectionQuadrilateral3D4N1201 
IntersectionQuadrilateral3D4N2101 
IntersectionQuadrilateral3D4N2301 
IntersectionQuadrilateral3D4N3201 
IntersectionQuadrilateral3D4N3001 
IntersectionQuadrilateral3D4N0301 
IntersectionQuadrilateral3D4N0110 
IntersectionQuadrilateral3D4N1010 
IntersectionQuadrilateral3D4N1210 
IntersectionQuadrilateral3D4N2110 
IntersectionQuadrilateral3D4N2310 
IntersectionQuadrilateral3D4N3210 
IntersectionQuadrilateral3D4N3010 
IntersectionQuadrilateral3D4N0310 
IntersectionQuadrilateral3D4N0112 
IntersectionQuadrilateral3D4N1012 
IntersectionQuadrilateral3D4N1212 
IntersectionQuadrilateral3D4N2112 
IntersectionQuadrilateral3D4N2312 
IntersectionQuadrilateral3D4N3212 
IntersectionQuadrilateral3D4N3012 
IntersectionQuadrilateral3D4N0312 
IntersectionQuadrilateral3D4N0121 
IntersectionQuadrilateral3D4N1021 
IntersectionQuadrilateral3D4N1221 
IntersectionQuadrilateral3D4N2121 
IntersectionQuadrilateral3D4N2321 
IntersectionQuadrilateral3D4N3221 
IntersectionQuadrilateral3D4N3021 
IntersectionQuadrilateral3D4N0321 
IntersectionQuadrilateral3D4N0123 
IntersectionQuadrilateral3D4N1023 
IntersectionQuadrilateral3D4N1223 
IntersectionQuadrilateral3D4N2123 
IntersectionQuadrilateral3D4N2323 
IntersectionQuadrilateral3D4N3223 
IntersectionQuadrilateral3D4N3023 
IntersectionQuadrilateral3D4N0323 
IntersectionQuadrilateral3D4N0132 
IntersectionQuadrilateral3D4N1032 
IntersectionQuadrilateral3D4N1232 
IntersectionQuadrilateral3D4N2132 
IntersectionQuadrilateral3D4N2332 
IntersectionQuadrilateral3D4N3232 
IntersectionQuadrilateral3D4N3032 
IntersectionQuadrilateral3D4N0332 
IntersectionQuadrilateral3D4N0130 
IntersectionQuadrilateral3D4N1030 
IntersectionQuadrilateral3D4N1230 
IntersectionQuadrilateral3D4N2130 
IntersectionQuadrilateral3D4N2330 
IntersectionQuadrilateral3D4N3230 
IntersectionQuadrilateral3D4N3030 
IntersectionQuadrilateral3D4N0330 
IntersectionQuadrilateral3D4N0103 
IntersectionQuadrilateral3D4N1003 
IntersectionQuadrilateral3D4N1203 
IntersectionQuadrilateral3D4N2103 
IntersectionQuadrilateral3D4N2303 
IntersectionQuadrilateral3D4N3203 
IntersectionQuadrilateral3D4N3003 
IntersectionQuadrilateral3D4N0303 

◆ PointBelongsQuadrilateral3D4NTriangle3D3N

Case for 3D triangle intersected with quadrilateral 3D.

Enumerator
SlaveQuadrilateral3D4N0 
SlaveQuadrilateral3D4N1 
SlaveQuadrilateral3D4N2 
SlaveQuadrilateral3D4N3 
MasterTriangle3D3N0 
MasterTriangle3D3N1 
MasterTriangle3D3N2 
IntersectionQuadrilateral3D4NTriangle3D3N 
IntersectionQuadrilateral3D4NTriangle3D3N0101 
IntersectionQuadrilateral3D4NTriangle3D3N1001 
IntersectionQuadrilateral3D4NTriangle3D3N1201 
IntersectionQuadrilateral3D4NTriangle3D3N2101 
IntersectionQuadrilateral3D4NTriangle3D3N2301 
IntersectionQuadrilateral3D4NTriangle3D3N3201 
IntersectionQuadrilateral3D4NTriangle3D3N3001 
IntersectionQuadrilateral3D4NTriangle3D3N0301 
IntersectionQuadrilateral3D4NTriangle3D3N0110 
IntersectionQuadrilateral3D4NTriangle3D3N1010 
IntersectionQuadrilateral3D4NTriangle3D3N1210 
IntersectionQuadrilateral3D4NTriangle3D3N2110 
IntersectionQuadrilateral3D4NTriangle3D3N2310 
IntersectionQuadrilateral3D4NTriangle3D3N3210 
IntersectionQuadrilateral3D4NTriangle3D3N3010 
IntersectionQuadrilateral3D4NTriangle3D3N0310 
IntersectionQuadrilateral3D4NTriangle3D3N0112 
IntersectionQuadrilateral3D4NTriangle3D3N1012 
IntersectionQuadrilateral3D4NTriangle3D3N1212 
IntersectionQuadrilateral3D4NTriangle3D3N2112 
IntersectionQuadrilateral3D4NTriangle3D3N2312 
IntersectionQuadrilateral3D4NTriangle3D3N3212 
IntersectionQuadrilateral3D4NTriangle3D3N3012 
IntersectionQuadrilateral3D4NTriangle3D3N0312 
IntersectionQuadrilateral3D4NTriangle3D3N0121 
IntersectionQuadrilateral3D4NTriangle3D3N1021 
IntersectionQuadrilateral3D4NTriangle3D3N1221 
IntersectionQuadrilateral3D4NTriangle3D3N2121 
IntersectionQuadrilateral3D4NTriangle3D3N2321 
IntersectionQuadrilateral3D4NTriangle3D3N3221 
IntersectionQuadrilateral3D4NTriangle3D3N3021 
IntersectionQuadrilateral3D4NTriangle3D3N0321 
IntersectionQuadrilateral3D4NTriangle3D3N0120 
IntersectionQuadrilateral3D4NTriangle3D3N1020 
IntersectionQuadrilateral3D4NTriangle3D3N1220 
IntersectionQuadrilateral3D4NTriangle3D3N2120 
IntersectionQuadrilateral3D4NTriangle3D3N2320 
IntersectionQuadrilateral3D4NTriangle3D3N3220 
IntersectionQuadrilateral3D4NTriangle3D3N3020 
IntersectionQuadrilateral3D4NTriangle3D3N0320 
IntersectionQuadrilateral3D4NTriangle3D3N0102 
IntersectionQuadrilateral3D4NTriangle3D3N1002 
IntersectionQuadrilateral3D4NTriangle3D3N1202 
IntersectionQuadrilateral3D4NTriangle3D3N2102 
IntersectionQuadrilateral3D4NTriangle3D3N2302 
IntersectionQuadrilateral3D4NTriangle3D3N3202 
IntersectionQuadrilateral3D4NTriangle3D3N3002 
IntersectionQuadrilateral3D4NTriangle3D3N0302 

◆ PointBelongsTriangle3D3N

Case for 3D triangle intersected with another 3D triangle.

Enumerator
SlaveTriangle3D3N0 
SlaveTriangle3D3N1 
SlaveTriangle3D3N2 
MasterTriangle3D3N0 
MasterTriangle3D3N1 
MasterTriangle3D3N2 
IntersectionTriangle3D3N 
IntersectionTriangle3D3N0101 
IntersectionTriangle3D3N1001 
IntersectionTriangle3D3N1201 
IntersectionTriangle3D3N2101 
IntersectionTriangle3D3N0201 
IntersectionTriangle3D3N2001 
IntersectionTriangle3D3N0110 
IntersectionTriangle3D3N1010 
IntersectionTriangle3D3N1210 
IntersectionTriangle3D3N2110 
IntersectionTriangle3D3N0210 
IntersectionTriangle3D3N2010 
IntersectionTriangle3D3N0112 
IntersectionTriangle3D3N1012 
IntersectionTriangle3D3N1212 
IntersectionTriangle3D3N2112 
IntersectionTriangle3D3N0212 
IntersectionTriangle3D3N2012 
IntersectionTriangle3D3N0121 
IntersectionTriangle3D3N1021 
IntersectionTriangle3D3N1221 
IntersectionTriangle3D3N2121 
IntersectionTriangle3D3N0221 
IntersectionTriangle3D3N2021 
IntersectionTriangle3D3N0102 
IntersectionTriangle3D3N1002 
IntersectionTriangle3D3N1202 
IntersectionTriangle3D3N2102 
IntersectionTriangle3D3N0202 
IntersectionTriangle3D3N2002 
IntersectionTriangle3D3N0120 
IntersectionTriangle3D3N1020 
IntersectionTriangle3D3N1220 
IntersectionTriangle3D3N2120 
IntersectionTriangle3D3N0220 
IntersectionTriangle3D3N2020 

◆ PointBelongsTriangle3D3NQuadrilateral3D4N

Case for 3D quadrilateral intersected with triangle 3D.

Enumerator
SlaveTriangle3D3N0 
SlaveTriangle3D3N1 
SlaveTriangle3D3N2 
MasterQuadrilateral3D4N0 
MasterQuadrilateral3D4N1 
MasterQuadrilateral3D4N2 
MasterQuadrilateral3D4N3 
IntersectionTriangle3D3NQuadrilateral3D4N 
IntersectionTriangle3D3NQuadrilateral3D4N0101 
IntersectionTriangle3D3NQuadrilateral3D4N0110 
IntersectionTriangle3D3NQuadrilateral3D4N0112 
IntersectionTriangle3D3NQuadrilateral3D4N0121 
IntersectionTriangle3D3NQuadrilateral3D4N0123 
IntersectionTriangle3D3NQuadrilateral3D4N0132 
IntersectionTriangle3D3NQuadrilateral3D4N0130 
IntersectionTriangle3D3NQuadrilateral3D4N0103 
IntersectionTriangle3D3NQuadrilateral3D4N1001 
IntersectionTriangle3D3NQuadrilateral3D4N1010 
IntersectionTriangle3D3NQuadrilateral3D4N1012 
IntersectionTriangle3D3NQuadrilateral3D4N1021 
IntersectionTriangle3D3NQuadrilateral3D4N1023 
IntersectionTriangle3D3NQuadrilateral3D4N1032 
IntersectionTriangle3D3NQuadrilateral3D4N1030 
IntersectionTriangle3D3NQuadrilateral3D4N1003 
IntersectionTriangle3D3NQuadrilateral3D4N1201 
IntersectionTriangle3D3NQuadrilateral3D4N1210 
IntersectionTriangle3D3NQuadrilateral3D4N1212 
IntersectionTriangle3D3NQuadrilateral3D4N1221 
IntersectionTriangle3D3NQuadrilateral3D4N1223 
IntersectionTriangle3D3NQuadrilateral3D4N1232 
IntersectionTriangle3D3NQuadrilateral3D4N1230 
IntersectionTriangle3D3NQuadrilateral3D4N1203 
IntersectionTriangle3D3NQuadrilateral3D4N2101 
IntersectionTriangle3D3NQuadrilateral3D4N2110 
IntersectionTriangle3D3NQuadrilateral3D4N2112 
IntersectionTriangle3D3NQuadrilateral3D4N2121 
IntersectionTriangle3D3NQuadrilateral3D4N2123 
IntersectionTriangle3D3NQuadrilateral3D4N2132 
IntersectionTriangle3D3NQuadrilateral3D4N2130 
IntersectionTriangle3D3NQuadrilateral3D4N2103 
IntersectionTriangle3D3NQuadrilateral3D4N2001 
IntersectionTriangle3D3NQuadrilateral3D4N2010 
IntersectionTriangle3D3NQuadrilateral3D4N2012 
IntersectionTriangle3D3NQuadrilateral3D4N2021 
IntersectionTriangle3D3NQuadrilateral3D4N2023 
IntersectionTriangle3D3NQuadrilateral3D4N2032 
IntersectionTriangle3D3NQuadrilateral3D4N2030 
IntersectionTriangle3D3NQuadrilateral3D4N2003 
IntersectionTriangle3D3NQuadrilateral3D4N0201 
IntersectionTriangle3D3NQuadrilateral3D4N0210 
IntersectionTriangle3D3NQuadrilateral3D4N0212 
IntersectionTriangle3D3NQuadrilateral3D4N0221 
IntersectionTriangle3D3NQuadrilateral3D4N0223 
IntersectionTriangle3D3NQuadrilateral3D4N0232 
IntersectionTriangle3D3NQuadrilateral3D4N0230 
IntersectionTriangle3D3NQuadrilateral3D4N0203 

◆ SCALING_DIAGONAL

Enumerator
NO_SCALING 
CONSIDER_NORM_DIAGONAL 
CONSIDER_MAX_DIAGONAL 
CONSIDER_PRESCRIBED_DIAGONAL 

◆ ShellKinematics

Enumerator
LINEAR 
NONLINEAR_COROTATIONAL 

◆ SofteningType

enum Kratos::SofteningType
strong
Enumerator
Linear 
Exponential 
HardeningDamage 
CurveFittingDamage 

◆ SpatialContainer

This enum defines the different spatial containers available.

The different spatial containers available are:

  • KDTree: This is a tree based on the k-d tree algorithm
  • Octree: This is a tree based on the octree algorithm
  • BinsStatic: This is a bin based on the static bins algorithm
  • BinsDynamic: This is a bin based on the dynamic bins algorithm
Enumerator
KDTree 
Octree 
BinsStatic 
BinsDynamic 

◆ StressTreatment

Enumerator
Mean 
Node 
GaussPoint 

◆ TangentOperatorEstimation

Enumerator
Analytic 
FirstOrderPerturbation 
SecondOrderPerturbation 
Secant 
SecondOrderPerturbationV2 
InitialStiffness 

◆ TracedStressType

Enumerator
FX 
FY 
FZ 
MX 
MY 
MZ 
FXX 
FXY 
FXZ 
FYX 
FYY 
FYZ 
FZX 
FZY 
FZZ 
MXX 
MXY 
MXZ 
MYX 
MYY 
MYZ 
MZX 
MZY 
MZZ 
PK2 
VON_MISES_STRESS 

◆ WriteConditionsFlag

Enumerator
WriteConditions 
WriteElementsOnly 
WriteConditionsOnly 

◆ WriteDeformedMeshFlag

Flags for mesh writing.

Enumerator
WriteDeformed 
WriteUndeformed 

Function Documentation

◆ AddKratosComponent() [1/21]

void Kratos::AddKratosComponent ( const std::string &  rName,
const Flags rComponent 
)

◆ AddKratosComponent() [2/21]

template<class TComponentType >
void Kratos::AddKratosComponent ( const std::string &  rName,
const TComponentType &  rComponent 
)

◆ AddKratosComponent() [3/21]

void Kratos::AddKratosComponent ( const std::string &  rName,
const Variable< array_1d< double, 3 >> &  rComponent 
)

◆ AddKratosComponent() [4/21]

void Kratos::AddKratosComponent ( const std::string &  rName,
const Variable< array_1d< double, 4 >> &  rComponent 
)

◆ AddKratosComponent() [5/21]

void Kratos::AddKratosComponent ( const std::string &  rName,
const Variable< array_1d< double, 6 >> &  rComponent 
)

◆ AddKratosComponent() [6/21]

void Kratos::AddKratosComponent ( const std::string &  rName,
const Variable< array_1d< double, 9 >> &  rComponent 
)

◆ AddKratosComponent() [7/21]

void Kratos::AddKratosComponent ( const std::string &  rName,
const Variable< bool > &  rComponent 
)

◆ AddKratosComponent() [8/21]

void Kratos::AddKratosComponent ( const std::string &  rName,
const Variable< double > &  rComponent 
)

◆ AddKratosComponent() [9/21]

void Kratos::AddKratosComponent ( const std::string &  rName,
const Variable< Flags > &  rComponent 
)

◆ AddKratosComponent() [10/21]

void Kratos::AddKratosComponent ( const std::string &  rName,
const Variable< int > &  rComponent 
)

◆ AddKratosComponent() [11/21]

void Kratos::AddKratosComponent ( const std::string &  rName,
const Variable< Quaternion< double >> &  rComponent 
)

◆ AddKratosComponent() [12/21]

void Kratos::AddKratosComponent ( const std::string &  rName,
const Variable< std::string > &  rComponent 
)

◆ AddKratosComponent() [13/21]

void Kratos::AddKratosComponent ( const std::string &  rName,
const Variable< unsigned int > &  rComponent 
)

◆ AddKratosComponent() [14/21]

void Kratos::AddKratosComponent ( const std::string &  rName,
const Variable< Vector > &  rComponent 
)

◆ AddKratosComponent() [15/21]

void Kratos::AddKratosComponent ( std::string const &  Name,
Condition const &  ThisComponent 
)

◆ AddKratosComponent() [16/21]

void Kratos::AddKratosComponent ( std::string const &  Name,
ConstitutiveLaw const &  ThisComponent 
)

◆ AddKratosComponent() [17/21]

void Kratos::AddKratosComponent ( std::string const &  Name,
Element const &  ThisComponent 
)

◆ AddKratosComponent() [18/21]

void Kratos::AddKratosComponent ( std::string const &  Name,
ExplicitBuilderType const &  ThisComponent 
)

◆ AddKratosComponent() [19/21]

void Kratos::AddKratosComponent ( std::string const &  Name,
Geometry< Node > const &  ThisComponent 
)

◆ AddKratosComponent() [20/21]

void Kratos::AddKratosComponent ( std::string const &  Name,
Modeler const &  ThisComponent 
)

◆ AddKratosComponent() [21/21]

void Kratos::AddKratosComponent ( std::string const &  Name,
Variable< ConstitutiveLaw::Pointer > const &  ThisComponent 
)

◆ AMGCLBlockSolve() [1/2]

template<int TBlockSize>
void Kratos::AMGCLBlockSolve ( TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::MatrixType &  rA,
TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::VectorType rX,
TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::VectorType rB,
TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::IndexType rIterationNumber,
double rResidual,
boost::property_tree::ptree  amgclParams,
int  verbosity_level,
bool  use_gpgpu 
)

◆ AMGCLBlockSolve() [2/2]

template<int TBlockSize>
void Kratos::AMGCLBlockSolve ( TUblasSparseSpace< double >::MatrixType &  rA,
TUblasSparseSpace< double >::VectorType rX,
TUblasSparseSpace< double >::VectorType rB,
TUblasSparseSpace< double >::IndexType rIterationNumber,
double rResidual,
boost::property_tree::ptree  amgclParams,
int  verbosity_level,
bool  use_gpgpu 
)

◆ AMGCLScalarSolve() [1/2]

void Kratos::AMGCLScalarSolve ( TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::MatrixType &  rA,
TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::VectorType rX,
TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::VectorType rB,
TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::IndexType rIterationNumber,
double rResidual,
const boost::property_tree::ptree &  amgclParams,
int  verbosity_level,
bool  use_gpgpu 
)

◆ AMGCLScalarSolve() [2/2]

void Kratos::AMGCLScalarSolve ( TUblasSparseSpace< double >::MatrixType &  rA,
TUblasSparseSpace< double >::VectorType rX,
TUblasSparseSpace< double >::VectorType rB,
TUblasSparseSpace< double >::IndexType rIterationNumber,
double rResidual,
const boost::property_tree::ptree &  amgclParams,
int  verbosity_level,
bool  use_gpgpu 
)

◆ AMGCLSolve() [1/2]

void Kratos::AMGCLSolve ( int  block_size,
TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::MatrixType &  rA,
TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::VectorType rX,
TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::VectorType rB,
TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector >::IndexType rIterationNumber,
double rResidual,
boost::property_tree::ptree  amgclParams,
int  verbosity_level,
bool  use_gpgpu 
)

◆ AMGCLSolve() [2/2]

void Kratos::AMGCLSolve ( int  block_size,
TUblasSparseSpace< double >::MatrixType &  rA,
TUblasSparseSpace< double >::VectorType rX,
TUblasSparseSpace< double >::VectorType rB,
TUblasSparseSpace< double >::IndexType rIterationNumber,
double rResidual,
boost::property_tree::ptree  amgclParams,
int  verbosity_level,
bool  use_gpgpu 
)

This function solves with Ublas Matrix type.

Parameters
block_sizeBlock size
rASystem matrix
rXSolution vector. It's also the initial guess for iterative linear solvers.
rBRight hand side vector.
rIterationNumberThe current number of iterations
rResidualThe current residual of the problem

◆ AtomicAdd() [1/2]

template<class TDataType , std::size_t ArraySize>
void Kratos::AtomicAdd ( array_1d< TDataType, ArraySize > &  target,
const array_1d< TDataType, ArraySize > &  value 
)
inline
Parameters
targetvariable being atomically updated by doing target += value
valuevalue being added Specialization for array_1d Note that the update is not really atomic, but rather is done component by component

◆ AtomicAdd() [2/2]

template<class TDataType >
void Kratos::AtomicAdd ( TDataType &  target,
const TDataType &  value 
)
inline

collection of utilities for atomic updates of simple types. (essentially mimics the omp atomic)

Parameters
targetvariable being atomically updated by doing target += value
valuevalue being added

◆ AtomicAddMatrix()

template<class TMatrixType1 , class TMatrixType2 >
void Kratos::AtomicAddMatrix ( TMatrixType1 &  target,
const TMatrixType2 &  value 
)
inline
Parameters
targetmatrix variable being atomically updated by doing target -= value
valuematrix value being subtracted Note that the update is not really atomic, but rather is done component by component

◆ AtomicAddVector()

template<class TVectorType1 , class TVectorType2 >
void Kratos::AtomicAddVector ( TVectorType1 &  target,
const TVectorType2 &  value 
)
inline
Parameters
targetvector variable being atomically updated by doing target += value
valuevector value being added Note that the update is not really atomic, but rather is done component by component

◆ AtomicDiv() [1/2]

template<class TDataType , std::size_t ArraySize>
void Kratos::AtomicDiv ( array_1d< TDataType, ArraySize > &  target,
const array_1d< TDataType, ArraySize > &  value 
)
inline
Parameters
targetvariable being atomically updated by doing target *= 1.0/value
valuevalue being divided Specialization for array_1d Note that the update is not really atomic, but rather is done component by component

◆ AtomicDiv() [2/2]

template<class TDataType >
void Kratos::AtomicDiv ( TDataType &  target,
const TDataType &  value 
)
inline
Parameters
targetvector variable being atomically updated by doing target *= 1.0/value
valuevector value being divided

◆ AtomicDivMatrix()

template<class TMatrixType1 , class TMatrixType2 >
void Kratos::AtomicDivMatrix ( TMatrixType1 &  target,
const TMatrixType2 &  value 
)
inline
Parameters
targetmatrix variable being atomically updated by doing target *= 1.0/value
valuematrix value being divided Note that the update is not really atomic, but rather is done component by component

◆ AtomicDivVector()

template<class TVectorType1 , class TVectorType2 >
void Kratos::AtomicDivVector ( TVectorType1 &  target,
const TVectorType2 &  value 
)
inline
Parameters
targetvector variable being atomically updated by doing target *= 1.0/value
valuevector value being divided Note that the update is not really atomic, but rather is done component by component

◆ AtomicMult() [1/2]

template<class TDataType , std::size_t ArraySize>
void Kratos::AtomicMult ( array_1d< TDataType, ArraySize > &  target,
const array_1d< TDataType, ArraySize > &  value 
)
inline
Parameters
targetvariable being atomically updated by doing target *= value
valuevalue being multiplied Specialization for array_1d Note that the update is not really atomic, but rather is done component by component

◆ AtomicMult() [2/2]

template<class TDataType >
void Kratos::AtomicMult ( TDataType &  target,
const TDataType &  value 
)
inline
Parameters
targetvector variable being atomically updated by doing target *= value
valuevector value being multiplied

◆ AtomicMultMatrix()

template<class TMatrixType1 , class TMatrixType2 >
void Kratos::AtomicMultMatrix ( TMatrixType1 &  target,
const TMatrixType2 &  value 
)
inline
Parameters
targetmatrix variable being atomically updated by doing target *= value
valuematrix value being multiplied Note that the update is not really atomic, but rather is done component by component

◆ AtomicMultVector()

template<class TVectorType1 , class TVectorType2 >
void Kratos::AtomicMultVector ( TVectorType1 &  target,
const TVectorType2 &  value 
)
inline
Parameters
targetvector variable being atomically updated by doing target *= value
valuevector value being multiplied Note that the update is not really atomic, but rather is done component by component

◆ AtomicSub() [1/2]

template<class TDataType , std::size_t ArraySize>
void Kratos::AtomicSub ( array_1d< TDataType, ArraySize > &  target,
const array_1d< TDataType, ArraySize > &  value 
)
inline
Parameters
targetvariable being atomically updated by doing target -= value
valuevalue being subtracted Specialization for array_1d Note that the update is not really atomic, but rather is done component by component

◆ AtomicSub() [2/2]

template<class TDataType >
void Kratos::AtomicSub ( TDataType &  target,
const TDataType &  value 
)
inline
Parameters
targetvector variable being atomically updated by doing target -= value
valuevector value being subtracted

◆ AtomicSubMatrix()

template<class TMatrixType1 , class TMatrixType2 >
void Kratos::AtomicSubMatrix ( TMatrixType1 &  target,
const TMatrixType2 &  value 
)
inline
Parameters
targetmatrix variable being atomically updated by doing target -= value
valuematrix value being subtracted Note that the update is not really atomic, but rather is done component by component

◆ AtomicSubVector()

template<class TVectorType1 , class TVectorType2 >
void Kratos::AtomicSubVector ( TVectorType1 &  target,
const TVectorType2 &  value 
)
inline
Parameters
targetvector variable being atomically updated by doing target -= value
valuevector value being subtracted Note that the update is not really atomic, but rather is done component by component

◆ block_for_each() [1/8]

template<class TContainerType , class TThreadLocalStorage , class TFunctionType , std::enable_if_t<!std::is_same_v< std::iterator_traits< typename decltype(std::declval< std::remove_cv_t< TContainerType >>().begin())::value_type >, void >, bool > = true>
void Kratos::block_for_each ( TContainerType &&  v,
const TThreadLocalStorage &  tls,
TFunctionType &&  func 
)

simplified version of the basic loop with thread local storage (TLS) to enable template type deduction

Template Parameters
TContainerTypeA standard-conforming container type.
TThreadLocalStorageCopy constructible thread-local type.
TFunctionTypeFunctor operating on TContainerType::value_type.
Parameters
v- containers to be looped upon
tls- thread local storage
func- must be a function accepting as input TContainerType::value_type& and the thread local storage

◆ block_for_each() [2/8]

template<class TReducer , class TContainerType , class TThreadLocalStorage , class TFunctionType , std::enable_if_t<!std::is_same_v< std::iterator_traits< typename decltype(std::declval< std::remove_cv_t< TContainerType >>().begin())::value_type >, void >, bool > = true>
TReducer::return_type Kratos::block_for_each ( TContainerType &&  v,
const TThreadLocalStorage &  tls,
TFunctionType &&  func 
)

simplified version of the basic loop with reduction and thread local storage (TLS) to enable template type deduction

Template Parameters
TReducerReduction type to apply. See SumReduction as an example.
TContainerTypeA standard-conforming container type.
TThreadLocalStorageCopy constructible thread-local type.
TFunctionTypeFunctor operating on TContainerType::value_type.
Parameters
v- containers to be looped upon
tls- thread local storage
func- must be a function accepting as input TContainerType::value_type& and the thread local storage

◆ block_for_each() [3/8]

template<class TContainerType , class TFunctionType , std::enable_if_t<!std::is_same_v< std::iterator_traits< typename decltype(std::declval< std::remove_cv_t< TContainerType >>().begin())::value_type >, void >, bool > = true>
void Kratos::block_for_each ( TContainerType &&  v,
TFunctionType &&  func 
)

simplified version of the basic loop (without reduction) to enable template type deduction

Template Parameters
TContainerTypeA standard-conforming container type.
TFunctionTypeFunctor operating on TContainerType::value_type.
Parameters
v- containers to be looped upon
func- must be a unary function accepting as input TContainerType::value_type&

◆ block_for_each() [4/8]

template<class TReducer , class TContainerType , class TFunctionType , std::enable_if_t<!std::is_same_v< std::iterator_traits< typename decltype(std::declval< std::remove_cv_t< TContainerType >>().begin())::value_type >, void >, bool > = true>
TReducer::return_type Kratos::block_for_each ( TContainerType &&  v,
TFunctionType &&  func 
)

simplified version of the basic loop with reduction to enable template type deduction

Template Parameters
TReducerReduction type to apply. See SumReduction as an example.
TContainerTypeA standard-conforming container type.
TFunctionTypeFunctor operating on TContainerType::value_type.
Parameters
v- containers to be looped upon
func- must be a unary function accepting as input TContainerType::value_type&

◆ block_for_each() [5/8]

template<class TIterator , class TTLS , class TFunction , std::enable_if_t< std::is_base_of_v< std::input_iterator_tag, typename std::iterator_traits< TIterator >::iterator_category >, bool > = true>
void Kratos::block_for_each ( TIterator  itBegin,
TIterator  itEnd,
const TTLS &  rTLS,
TFunction &&  rFunction 
)

Execute a functor with thread local storage on all items of a range in parallel.

Template Parameters
TIteratorrandom access iterator.
TTLScopy constructible thread-local type.
TFunctionfunctor taking the dereferenced type of TIterator.
Parameters
itBeginiterator to the first item in the container to loop on.
itEnditerator past the last item in the container.
rTLSthread local storage
rFunctionfunction to execute on each item.

◆ block_for_each() [6/8]

template<class TReduction , class TIterator , class TTLS , class TFunction , std::enable_if_t< std::is_base_of_v< std::input_iterator_tag, typename std::iterator_traits< TIterator >::iterator_category >, bool > = true>
TReduction::return_type Kratos::block_for_each ( TIterator  itBegin,
TIterator  itEnd,
const TTLS &  tls,
TFunction &&  rFunction 
)

Execute a functor with thread local storage on all items of a range in parallel, and perform a reduction.

Template Parameters
TReductiontype of reduction to apply. See SumReduction for an example.
TIteratorrandom access iterator.
TTLScopy constructible thread-local type.
TFunctionfunctor taking the dereferenced type of TIterator.
Parameters
itBeginiterator to the first item in the container to loop on.
itEnditerator past the last item in the container.
rTLSthread local storage
rFunctionfunction to execute on each item.

◆ block_for_each() [7/8]

template<class TIterator , class TFunction , std::enable_if_t< std::is_base_of_v< std::input_iterator_tag, typename std::iterator_traits< TIterator >::iterator_category >, bool > = true>
void Kratos::block_for_each ( TIterator  itBegin,
TIterator  itEnd,
TFunction &&  rFunction 
)

Execute a functor on all items of a range in parallel.

Template Parameters
TIteratorrandom access iterator.
TFunctionfunctor taking the dereferenced type of TIterator.
Parameters
itBeginiterator to the first item in the container to loop on.
itEnditerator past the last item in the container.
rFunctionfunction to execute on each item.

◆ block_for_each() [8/8]

template<class TReduction , class TIterator , class TFunction , std::enable_if_t< std::is_base_of_v< std::input_iterator_tag, typename std::iterator_traits< TIterator >::iterator_category >, bool > = true>
TReduction::return_type Kratos::block_for_each ( TIterator  itBegin,
TIterator  itEnd,
TFunction &&  rFunction 
)

Execute a functor on all items of a range in parallel, and perform a reduction.

Template Parameters
TReductiontype of reduction to apply. See SumReduction for an example.
TIteratorrandom access iterator.
TFunctionfunctor taking the dereferenced type of TIterator.
Parameters
itBeginiterator to the first item in the container to loop on.
itEnditerator past the last item in the container.
rFunctionfunction to execute on each item.

◆ CalculateNormalizedIndentation()

double Kratos::CalculateNormalizedIndentation ( SphericParticle elem_it_1,
SphericParticle elem_it_2 
)
inline

◆ CalculatePosition() [1/2]

bool Kratos::CalculatePosition ( Geometry< Node > &  geom,
const double  xc,
const double  yc,
const double  zc,
array_1d< double, 3 > &  N 
)
inline

◆ CalculatePosition() [2/2]

bool Kratos::CalculatePosition ( Geometry< Node > &  geom,
const double  xc,
const double  yc,
const double  zc,
array_1d< double, 4 > &  N 
)
inline

◆ CalculateVol() [1/2]

double Kratos::CalculateVol ( const double  x0,
const double  y0,
const double  x1,
const double  y1,
const double  x2,
const double  y2 
)
inline

◆ CalculateVol() [2/2]

double Kratos::CalculateVol ( const double  x0,
const double  y0,
const double  z0,
const double  x1,
const double  y1,
const double  z1,
const double  x2,
const double  y2,
const double  z2,
const double  x3,
const double  y3,
const double  z3 
)
inline

◆ CheckThereIsNotx()

bool Kratos::CheckThereIsNotx ( const std::string &  rString)
inline

◆ column() [1/2]

template<typename TExpressionType , std::size_t TCategory>
AMatrix::MatrixColumn<TExpressionType> Kratos::column ( AMatrix::MatrixExpression< TExpressionType, TCategory > &  TheExpression,
std::size_t  ColumnIndex 
)

◆ column() [2/2]

template<typename TExpressionType , std::size_t TCategory>
AMatrix::MatrixColumn<const TExpressionType> Kratos::column ( AMatrix::MatrixExpression< TExpressionType, TCategory > const &  TheExpression,
std::size_t  ColumnIndex 
)

◆ ComputeMidpointShapeFunctions()

void Kratos::ComputeMidpointShapeFunctions ( const Geometry< Node > &  rGeometry,
Vector rN,
Matrix rDN_DX 
)

◆ Determine2DModelPart()

ModelPart& Kratos::Determine2DModelPart ( ModelPart rFirstModelPart,
ModelPart rSecondModelPart 
)

This method determines the 2D model part.

Parameters
rFirstModelPartThe first ModelPart
rSecondModelPartThe second ModelPart
Returns
The 2D model part

◆ Determine3DModelPart()

ModelPart& Kratos::Determine3DModelPart ( ModelPart rFirstModelPart,
ModelPart rSecondModelPart 
)

This method determines the 3D model part.

The counter part of the previous method

Parameters
rFirstModelPartThe first ModelPart
rSecondModelPartThe second ModelPart
Returns
The 3D model part

◆ DetermineModelPartMaximumLocalDimension()

unsigned int Kratos::DetermineModelPartMaximumLocalDimension ( ModelPart rModelPart)

This method determines maximum local space dimension of a ModelPart.

Parameters
rModelPartThe model part to be considered
Returns
The maximum local space dimension

◆ DeterminePartitionWithEntities()

int Kratos::DeterminePartitionWithEntities ( const ModelPart rModelPart)

This method determines the partition where the model part has at least one entity.

Parameters
rModelPartThe input model part where determine the partition with at least one entity
Returns
A partition with at least one partition

◆ FactorConditions() [1/2]

std::vector<ConditionsContainerType> Kratos::FactorConditions ( ConditionsContainerType const &  rConditions)

◆ FactorConditions() [2/2]

void Kratos::FactorConditions ( ConditionsContainerType const &  rConditions,
std::vector< std::string > &  rNames,
std::vector< ConditionsContainerType > &  rFactoredConditions 
)

◆ FactorElements() [1/2]

std::vector<ElementsContainerType> Kratos::FactorElements ( ElementsContainerType const &  rElements)

Factor a collection of elements into uniform containers.

Each container consists of all elements of a single type. In MPI, the sequence of element containers is global (i.e., the ith container on each process corresponds to the same element type), but the contents of each container on a process are local. If a process has no local elements corresponding to the ith container, it is empty.

◆ FactorElements() [2/2]

void Kratos::FactorElements ( ElementsContainerType const &  rElements,
std::vector< std::string > &  rNames,
std::vector< ElementsContainerType > &  rFactoredElements 
)

◆ FindNodeOnMesh()

template<unsigned int TDim>
class Kratos::MoveParticleUtilityDiffFluidOnly Kratos::FindNodeOnMesh ( array_1d< double, 3 > &  position,
array_1d< double, TDim+1 > &  N,
Element::Pointer &  pelement,
ResultIteratorType  result_begin,
const unsigned int  MaxNumberOfResults 
)

this function should find the element into which a given node is located and return a pointer to the element and the vector containing the shape functions that define the postion within the element if "false" is devolved the element is not found

◆ FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ConditionsContainerType, array_1d< double, 3 > >() [1/2]

◆ FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ConditionsContainerType, array_1d< double, 3 > >() [2/2]

template void Kratos::FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ConditionsContainerType, array_1d< double, 3 > > ( ModelPart::ConditionsContainerType ,
const Variable< array_1d< double, 3 >> &  ,
const std::string &  ,
const std::size_t  ,
const double  ,
const double   
)

◆ FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ConditionsContainerType, double >() [1/2]

◆ FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ConditionsContainerType, double >() [2/2]

template void Kratos::FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ConditionsContainerType, double > ( ModelPart::ConditionsContainerType ,
const Variable< double > &  ,
const std::string &  ,
const std::size_t  ,
const double  ,
const double   
)

◆ FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ElementsContainerType, array_1d< double, 3 > >() [1/2]

◆ FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ElementsContainerType, array_1d< double, 3 > >() [2/2]

template void Kratos::FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ElementsContainerType, array_1d< double, 3 > > ( ModelPart::ElementsContainerType ,
const Variable< array_1d< double, 3 >> &  ,
const std::string &  ,
const std::size_t  ,
const double  ,
const double   
)

◆ FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ElementsContainerType, double >() [1/2]

◆ FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ElementsContainerType, double >() [2/2]

template void Kratos::FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::ElementsContainerType, double > ( ModelPart::ElementsContainerType ,
const Variable< double > &  ,
const std::string &  ,
const std::size_t  ,
const double  ,
const double   
)

◆ FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::NodesContainerType, array_1d< double, 3 > >() [1/2]

◆ FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::NodesContainerType, array_1d< double, 3 > >() [2/2]

template void Kratos::FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::NodesContainerType, array_1d< double, 3 > > ( ModelPart::NodesContainerType ,
const Variable< array_1d< double, 3 >> &  ,
const std::string &  ,
const std::size_t  ,
const double  ,
const double   
)

◆ FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::NodesContainerType, double >() [1/2]

◆ FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::NodesContainerType, double >() [2/2]

template void Kratos::FluidTestUtilities::RandomFillNonHistoricalVariable< ModelPart::NodesContainerType, double > ( ModelPart::NodesContainerType ,
const Variable< double > &  ,
const std::string &  ,
const std::size_t  ,
const double  ,
const double   
)

◆ FluidTestUtilities::RunEntityEquationIdVectorTest< ModelPart::ConditionsContainerType >()

◆ FluidTestUtilities::RunEntityEquationIdVectorTest< ModelPart::ElementsContainerType >()

◆ FluidTestUtilities::RunEntityGetDofListTest< ModelPart::ConditionsContainerType >()

◆ FluidTestUtilities::RunEntityGetDofListTest< ModelPart::ElementsContainerType >()

◆ FluidTestUtilities::RunEntityGetFirstDerivativesVectorTest< ModelPart::ConditionsContainerType >()

◆ FluidTestUtilities::RunEntityGetFirstDerivativesVectorTest< ModelPart::ElementsContainerType >()

◆ FluidTestUtilities::RunEntityGetSecondDerivativesVectorTest< ModelPart::ConditionsContainerType >()

◆ FluidTestUtilities::RunEntityGetSecondDerivativesVectorTest< ModelPart::ElementsContainerType >()

◆ FluidTestUtilities::RunEntityGetValuesVectorTest< ModelPart::ConditionsContainerType >()

◆ FluidTestUtilities::RunEntityGetValuesVectorTest< ModelPart::ElementsContainerType >()

◆ GetBranchName()

std::string Kratos::GetBranchName ( )

◆ GetBuildType()

std::string Kratos::GetBuildType ( )

◆ GetCommit()

std::string Kratos::GetCommit ( )

◆ GetCompiler()

std::string Kratos::GetCompiler ( )

◆ GetFromProperty()

double Kratos::GetFromProperty ( const Properties rThisProperties,
Variable< double > &  rVariable 
)

◆ GetGeometryFromModelPart()

GeometryType::Pointer Kratos::GetGeometryFromModelPart ( const ModelPart rModelPart)

This method retrieves the first geometry from a model part.

Parameters
rModelPartThe input model part
Returns
The first geometry of the model part

◆ GetLocalNodes()

void Kratos::GetLocalNodes ( ModelPart::NodesContainerType const &  rNodes,
std::vector< ModelPart::NodeType * > &  rLocalNodes 
)

◆ GetMajorVersion()

constexpr int Kratos::GetMajorVersion ( )
constexpr

◆ GetMinorVersion()

constexpr int Kratos::GetMinorVersion ( )
constexpr

◆ GetMPIDatatype() [1/2]

MPI_Datatype Kratos::GetMPIDatatype ( const char &  rValue)
inline

◆ GetMPIDatatype() [2/2]

MPI_Datatype Kratos::GetMPIDatatype ( const double rValue)
inline

◆ GetOSName()

std::string Kratos::GetOSName ( )

◆ GetPatchVersion()

std::string Kratos::GetPatchVersion ( )

◆ GetVersionString()

std::string Kratos::GetVersionString ( )

◆ inner_prod()

template<typename TExpression1Type , typename TExpression2Type , std::size_t TCategory1, std::size_t TCategory2>
TExpression1Type::data_type Kratos::inner_prod ( AMatrix::MatrixExpression< TExpression1Type, TCategory1 > const &  First,
AMatrix::MatrixExpression< TExpression2Type, TCategory2 > const &  Second 
)

◆ IsCorrectType()

template<typename T >
constexpr bool Kratos::IsCorrectType ( MM_typecode mm_code)
constexpr

◆ IsCorrectType< double >()

template<>
constexpr bool Kratos::IsCorrectType< double > ( MM_typecode mm_code)
inlineconstexpr

◆ IsCorrectType< std::complex< double > >()

template<>
constexpr bool Kratos::IsCorrectType< std::complex< double > > ( MM_typecode mm_code)
inlineconstexpr

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [1/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( ADJOINT_CURVATURE  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [2/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( ADJOINT_RHS  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [3/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( ADJOINT_STRAIN  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [4/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( AUXILIARY_FIELD  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [5/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( BACKGROUND_COORDINATE  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [6/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( BACKGROUND_NORMAL  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [7/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( BEAD_DIRECTION  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [8/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( CONTROL_POINT_CHANGE  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [9/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( CONTROL_POINT_UPDATE  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [10/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( CORRECTION  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [11/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( CX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [12/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_CX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [13/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_LINEAR_D_CX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [14/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_LINEAR_D_X  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [15/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_MASS_D_CX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [16/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_MASS_D_X  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [17/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_MAX_OVERHANG_ANGLE_D_CX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [18/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_MAX_OVERHANG_ANGLE_D_X  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [19/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_PLANE_SYMMETRY_D_CX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [20/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_PLANE_SYMMETRY_D_X  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [21/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_STRAIN_ENERGY_1_D_CX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [22/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_STRAIN_ENERGY_1_D_X  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [23/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_STRAIN_ENERGY_2_D_CX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [24/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_STRAIN_ENERGY_2_D_X  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [25/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_STRAIN_ENERGY_3_D_CX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [26/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_STRAIN_ENERGY_3_D_X  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [27/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_STRESS_D_CX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [28/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_STRESS_D_X  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [29/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( D_X  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [30/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DAMPING_FACTOR  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [31/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC1DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [32/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC1DX_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [33/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC1DX_WEIGHTED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [34/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC1DX_WEIGHTED_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [35/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC2DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [36/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC2DX_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [37/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC2DX_WEIGHTED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [38/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC2DX_WEIGHTED_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [39/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC3DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [40/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC3DX_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [41/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC3DX_WEIGHTED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [42/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC3DX_WEIGHTED_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [43/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC4DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [44/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC4DX_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [45/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC4DX_WEIGHTED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [46/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC4DX_WEIGHTED_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [47/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC5DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [48/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC5DX_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [49/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC5DX_WEIGHTED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [50/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC5DX_WEIGHTED_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [51/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC6DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [52/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC6DX_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [53/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC6DX_WEIGHTED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [54/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC6DX_WEIGHTED_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [55/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC7DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [56/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC7DX_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [57/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC7DX_WEIGHTED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [58/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC7DX_WEIGHTED_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [59/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC8DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [60/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC8DX_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [61/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC8DX_WEIGHTED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [62/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC8DX_WEIGHTED_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [63/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC9DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [64/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC9DX_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [65/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC9DX_WEIGHTED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [66/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DC9DX_WEIGHTED_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [67/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DF1DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [68/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DF1DX_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [69/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DF1DX_WEIGHTED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [70/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DF1DX_WEIGHTED_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [71/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DP1DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [72/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( DPF1DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [73/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( FSI_INTERFACE_MESH_RESIDUAL  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [74/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( FSI_INTERFACE_RESIDUAL  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [75/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( HEATMAP_DC1DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [76/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( HEATMAP_DC2DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [77/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( HEATMAP_DC3DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [78/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( HEATMAP_DC4DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [79/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( HEATMAP_DC5DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [80/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( HEATMAP_DC6DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [81/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( HEATMAP_DC7DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [82/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( HEATMAP_DC8DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [83/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( HEATMAP_DC9DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [84/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( HEATMAP_DF1DX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [85/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( HELMHOLTZ_SOURCE_SHAPE  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [86/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( HELMHOLTZ_VARS_SHAPE  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [87/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( HELMHOLTZ_VECTOR  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [88/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( HELMHOLTZ_VECTOR_SOURCE  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [89/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( MAPPER_VECTOR_PROJECTION_RHS  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [90/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( MESH_CHANGE  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [91/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( NEAREST_NEIGHBOUR_POINT  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [92/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( NEGATIVE_MAPPED_VECTOR_VARIABLE  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [93/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( NODAL_DISPLACEMENT_STIFFNESS_SENSITIVITY  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [94/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( NODAL_ROTATIONAL_STIFFNESS_SENSITIVITY  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [95/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( NORMALIZED_SURFACE_NORMAL  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [96/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( OLD_RELAXED_DISPLACEMENT  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [97/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( OLD_RELAXED_TRACTION  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [98/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( OUT_OF_PLANE_DELTA  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [99/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( POINT_LOAD_SENSITIVITY  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [100/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( POSITIVE_MAPPED_VECTOR_VARIABLE  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [101/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( PROJECTION  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [102/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( RELAXED_DISPLACEMENT  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [103/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( RELAXED_TRACTION  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [104/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( ROTATION_MESH_DISPLACEMENT  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [105/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( ROTATION_MESH_VELOCITY  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [106/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( SEARCH_DIRECTION  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [107/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( SHAPE  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [108/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( SHAPE_CHANGE  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [109/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( SHAPE_UPDATE  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [110/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( SX  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [111/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( TABLE_NUMBER_VELOCITY  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [112/122]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR NORMAL_GAP Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( TANGENT_SLIP  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [113/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( TEMPORARY_ARRAY3_VARIABLE_1  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [114/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( TEMPORARY_ARRAY3_VARIABLE_2  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [115/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( TRACTION_INTERFACE_RESIDUAL  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [116/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( VAUX_EQ_TRACTION  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [117/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( VECTOR_PROJECTED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [118/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( VECTOR_TO_UPWIND_ELEMENT  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [119/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( VECTOR_VARIABLE  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [120/122]

Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( VECTOR_VARIABLE_MAPPED  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [121/122]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR NORMAL_GAP WEIGHTED_GAP Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( WEIGHTED_SLIP  )

◆ KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS() [122/122]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL Kratos::KRATOS_CREATE_3D_VARIABLE_WITH_COMPONENTS ( WEIGHTED_VECTOR_RESIDUAL  )

◆ KRATOS_CREATE_LOCAL_FLAG() [1/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ApplyConstantVectorValueProcess  ,
X_COMPONENT_FIXED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [2/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ApplyConstantVectorValueProcess  ,
Y_COMPONENT_FIXED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [3/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ApplyConstantVectorValueProcess  ,
Z_COMPONENT_FIXED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [4/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( BeamElement  ,
COMPUTE_LHS_MATRIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [5/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( BeamElement  ,
COMPUTE_RHS_VECTOR  ,
 
)

Flags related to the element computation

◆ KRATOS_CREATE_LOCAL_FLAG() [6/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( BeamElement  ,
FINALIZED_STEP  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [7/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( BeamPointRigidContactCondition  ,
COMPUTE_LHS_MATRIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [8/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( BeamPointRigidContactCondition  ,
COMPUTE_LHS_MATRIX_WITH_COMPONENTS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [9/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( BeamPointRigidContactCondition  ,
COMPUTE_RHS_VECTOR  ,
 
)

Flags related to the condition computation

◆ KRATOS_CREATE_LOCAL_FLAG() [10/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( BeamPointRigidContactCondition  ,
COMPUTE_RHS_VECTOR_WITH_COMPONENTS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [11/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( BoundaryCondition  ,
COMPUTE_LHS_MATRIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [12/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( BoundaryCondition  ,
COMPUTE_RHS_VECTOR  ,
 
)

Flags related to the condition computation

◆ KRATOS_CREATE_LOCAL_FLAG() [13/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( CalculateDiscontinuousDistanceToSkinProcessFlags  ,
CALCULATE_ELEMENTAL_EDGE_DISTANCES  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [14/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( CalculateDiscontinuousDistanceToSkinProcessFlags  ,
CALCULATE_ELEMENTAL_EDGE_DISTANCES_EXTRAPOLATED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [15/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( CalculateDiscontinuousDistanceToSkinProcessFlags  ,
USE_POSITIVE_EPSILON_FOR_ZERO_VALUES  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [16/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
ANISOTROPIC  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [17/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
AXISYMMETRIC_LAW  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [18/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
COMPUTE_CONSTITUTIVE_TENSOR  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [19/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
COMPUTE_STRAIN_ENERGY  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [20/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
COMPUTE_STRESS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [21/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
FINALIZE_MATERIAL_RESPONSE  ,
10   
)

◆ KRATOS_CREATE_LOCAL_FLAG() [22/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
FINITE_STRAINS  ,
 
)

Flags related to the Features of the Constitutive Law

◆ KRATOS_CREATE_LOCAL_FLAG() [23/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
INCREMENTAL_STRAIN_MEASURE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [24/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
INFINITESIMAL_STRAINS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [25/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
INITIALIZE_MATERIAL_RESPONSE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [26/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
ISOCHORIC_TENSOR_ONLY  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [27/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
ISOTROPIC  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [28/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
MECHANICAL_RESPONSE_ONLY  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [29/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
PLANE_STRAIN_LAW  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [30/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
PLANE_STRESS_LAW  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [31/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
THERMAL_RESPONSE_ONLY  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [32/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
THREE_DIMENSIONAL_LAW  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [33/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
U_P_LAW  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [34/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
USE_ELEMENT_PROVIDED_STRAIN  ,
 
)

Flags related to the Parameters of the Constitutive Law

◆ KRATOS_CREATE_LOCAL_FLAG() [35/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveLaw  ,
VOLUMETRIC_TENSOR_ONLY  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [36/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveModel  ,
ADD_HISTORY_VECTOR  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [37/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveModel  ,
HISTORY_STRAIN_MEASURE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [38/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveModel  ,
HISTORY_STRESS_MEASURE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [39/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveModelData  ,
CONSTITUTIVE_MATRIX_COMPUTED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [40/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveModelData  ,
IMPLEX_ACTIVE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [41/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveModelData  ,
PLASTIC_RATE_REGION  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [42/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveModelData  ,
PLASTIC_REGION  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [43/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveModelData  ,
RETURN_MAPPING_COMPUTED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [44/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveModelData  ,
STRAIN_COMPUTED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [45/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveModelData  ,
STRESS_COMPUTED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [46/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ConstitutiveModelData  ,
UPDATE_INTERNAL_VARIABLES  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [47/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ContactDomainUtilities  ,
COMPUTE_FRICTION_FORCES  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [48/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ContactDomainUtilities  ,
COMPUTE_FRICTION_STIFFNESS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [49/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ContactDomainUtilities  ,
COMPUTE_LHS_MATRIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [50/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ContactDomainUtilities  ,
COMPUTE_LHS_MATRIX_WITH_COMPONENTS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [51/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ContactDomainUtilities  ,
COMPUTE_NODAL_CONTACT_FORCES  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [52/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ContactDomainUtilities  ,
COMPUTE_RHS_VECTOR  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [53/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ContactDomainUtilities  ,
COMPUTE_RHS_VECTOR_WITH_COMPONENTS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [54/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( CriterionLocalFlags  ,
AND  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [55/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( CriterionLocalFlags  ,
CONVERGED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [56/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( CriterionLocalFlags  ,
INCREMENTAL  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [57/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( CriterionLocalFlags  ,
INITIALIZED  ,
 
)

Flags for the convergence criterion control

◆ KRATOS_CREATE_LOCAL_FLAG() [58/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( CriterionLocalFlags  ,
OR  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [59/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( CriterionLocalFlags  ,
SUPPLIED_DOF  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [60/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( CriterionLocalFlags  ,
UPDATE_RHS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [61/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DataValueContainer  ,
OVERWRITE_OLD_VALUES  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [62/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMFlags  ,
BELONGS_TO_A_CLUSTER  ,
10   
)

◆ KRATOS_CREATE_LOCAL_FLAG() [63/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMFlags  ,
COPIED_STRESS_TENSOR  ,
12   
)

◆ KRATOS_CREATE_LOCAL_FLAG() [64/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMFlags  ,
COPIED_STRESS_TENSOR2  ,
13   
)

◆ KRATOS_CREATE_LOCAL_FLAG() [65/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMFlags  ,
CUMULATIVE_ZONE  ,
15   
)

◆ KRATOS_CREATE_LOCAL_FLAG() [66/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMFlags  ,
FIXED_ANG_VEL_X  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [67/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMFlags  ,
FIXED_ANG_VEL_Y  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [68/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMFlags  ,
FIXED_ANG_VEL_Z  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [69/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMFlags  ,
FIXED_VEL_X  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [70/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMFlags  ,
FIXED_VEL_Y  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [71/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMFlags  ,
FIXED_VEL_Z  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [72/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMFlags  ,
HAS_CRITICAL_TIME  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [73/241]

PARTICLE_COHESION I33 BEAM_INERTIA_ROT_UNIT_LENGHT_Y KRATOS_CREATE_VARIABLE (double, BEAM_INERTIA_ROT_UNIT_LENGHT_Z) typedef std K_ALPHA NEIGHBOUR_PARTICLE_OF_RIGID_FACE Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMFlags  ,
HAS_ROLLING_FRICTION  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [74/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMFlags  ,
HAS_STRESS_TENSOR  ,
11   
)

◆ KRATOS_CREATE_LOCAL_FLAG() [75/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMFlags  ,
IS_SAND_PRODUCTION  ,
16   
)

◆ KRATOS_CREATE_LOCAL_FLAG() [76/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMFlags  ,
POLYHEDRON_SKIN  ,
17   
)

◆ KRATOS_CREATE_LOCAL_FLAG() [77/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMFlags  ,
PRINT_STRESS_TENSOR  ,
14   
)

◆ KRATOS_CREATE_LOCAL_FLAG() [78/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMFlags  ,
STICKY  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [79/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMThermalFlags  ,
IS_ADIABATIC  ,
18   
)

◆ KRATOS_CREATE_LOCAL_FLAG() [80/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( DEMThermalFlags  ,
IS_SINTERING  ,
19   
)

◆ KRATOS_CREATE_LOCAL_FLAG() [81/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( EntitiesEraseProcessFlags  ,
ERASE_ALL_ENTITIES  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [82/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( EntitiesEraseProcessFlags  ,
REMOVE_FROM_ALL_LEVELS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [83/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( EstimateDtUtility  ,
CFL_ESTIMATION  ,
 
)

Local flags to determine the magnitudes for the Dt estimation.

◆ KRATOS_CREATE_LOCAL_FLAG() [84/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( EstimateDtUtility  ,
THERMAL_FOURIER_ESTIMATION  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [85/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( EstimateDtUtility  ,
VISCOUS_FOURIER_ESTIMATION  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [86/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FindIntersectedGeometricalObjectsProcess  ,
INTERSECTED_CONDITIONS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [87/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FindIntersectedGeometricalObjectsProcess  ,
INTERSECTED_ELEMENTS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [88/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FindIntersectedGeometricalObjectsProcess  ,
INTERSECTING_CONDITIONS  ,
 
)

Local Flags.

◆ KRATOS_CREATE_LOCAL_FLAG() [89/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FindIntersectedGeometricalObjectsProcess  ,
INTERSECTING_ELEMENTS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [90/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FindIntersectedGeometricalObjectsWithOBBProcess  ,
BUILD_OBB_FROM_BB  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [91/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FindIntersectedGeometricalObjectsWithOBBProcess  ,
DEBUG_OBB  ,
 
)

Local Flags.

◆ KRATOS_CREATE_LOCAL_FLAG() [92/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FindIntersectedGeometricalObjectsWithOBBProcess  ,
SEPARATING_AXIS_THEOREM  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [93/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FlowRule  ,
IMPLEX_ACTIVE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [94/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FlowRule  ,
PLASTIC_RATE_REGION  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [95/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FlowRule  ,
PLASTIC_REGION  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [96/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FlowRule  ,
RETURN_MAPPING_COMPUTED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [97/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FluidElement  ,
COMPUTE_LHS_MATRIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [98/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FluidElement  ,
COMPUTE_RHS_VECTOR  ,
 
)

Flags related to the element computation

◆ KRATOS_CREATE_LOCAL_FLAG() [99/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FluidElement  ,
FINALIZED_STEP  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [100/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FromJSONCheckResultProcess  ,
CHECK_ONLY_LOCAL_ENTITIES  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [101/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FromJSONCheckResultProcess  ,
CORRECT_RESULT  ,
 
)

Local Flags.

◆ KRATOS_CREATE_LOCAL_FLAG() [102/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FromJSONCheckResultProcess  ,
ELEMENTS_CONTAINER_INITIALIZED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [103/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FromJSONCheckResultProcess  ,
ELEMENTS_DATABASE_INITIALIZED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [104/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FromJSONCheckResultProcess  ,
HISTORICAL_VALUE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [105/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FromJSONCheckResultProcess  ,
NODES_CONTAINER_INITIALIZED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [106/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( FromJSONCheckResultProcess  ,
NODES_DATABASE_INITIALIZED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [107/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( IgaFlags  ,
FIX_DISPLACEMENT_X  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [108/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( IgaFlags  ,
FIX_DISPLACEMENT_Y  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [109/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( IgaFlags  ,
FIX_DISPLACEMENT_Z  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [110/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( IgaFlags  ,
FIX_ROTATION_X  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [111/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( IgaFlags  ,
FIX_ROTATION_Y  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [112/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( IgaFlags  ,
FIX_ROTATION_Z  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [113/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( IntegrationInfo  ,
DO_NOT_CREATE_TESSELLATION_ON_SLAVE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [114/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( IO  ,
APPEND  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [115/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( IO  ,
IGNORE_VARIABLES_ERROR  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [116/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( IO  ,
MESH_ONLY  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [117/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( IO  ,
READ  ,
 
)

Local Flags.

◆ KRATOS_CREATE_LOCAL_FLAG() [118/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( IO  ,
SCIENTIFIC_PRECISION  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [119/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( IO  ,
SKIP_TIMER  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [120/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( IO  ,
WRITE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [121/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( LoggerOutput  ,
DEBUG_PREFIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [122/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( LoggerOutput  ,
DETAIL_PREFIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [123/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( LoggerOutput  ,
INFO_PREFIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [124/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( LoggerOutput  ,
TRACE_PREFIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [125/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( LoggerOutput  ,
WARNING_PREFIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [126/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MapperFlags  ,
ADD_VALUES  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [127/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MapperFlags  ,
DESTINATION_ONLY  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [128/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MapperFlags  ,
FROM_NON_HISTORICAL  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [129/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MapperFlags  ,
INTERNAL_USE_TRANSPOSE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [130/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MapperFlags  ,
ORIGIN_ONLY  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [131/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MapperFlags  ,
REMESHED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [132/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MapperFlags  ,
SWAP_SIGN  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [133/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MapperFlags  ,
TO_NON_HISTORICAL  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [134/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MapperFlags  ,
USE_TRANSPOSE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [135/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MeshCoarseningProcess  ,
COARSE_MESH_NODE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [136/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MeshDataTransferUtilities  ,
ELEMENT_TO_ELEMENT  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [137/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MeshDataTransferUtilities  ,
ELEMENT_TO_NODE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [138/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MeshDataTransferUtilities  ,
INITIALIZE_MASTER_CONDITION  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [139/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MeshDataTransferUtilities  ,
MASTER_ELEMENT_TO_MASTER_CONDITION  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [140/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MeshDataTransferUtilities  ,
NODE_TO_ELEMENT  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [141/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
BOUNDARIES_SEARCH  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [142/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
CONSTRAINED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [143/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
CONTACT_SEARCH  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [144/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
FINALIZE_MESHER_INPUT  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [145/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
INITIALIZE_MESHER_INPUT  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [146/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
KEEP_ISOLATED_NODES  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [147/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
MESH_SMOOTHING  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [148/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
NEIGHBOURS_SEARCH  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [149/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
PASS_ALPHA_SHAPE  ,
11   
)

◆ KRATOS_CREATE_LOCAL_FLAG() [150/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
RECONNECT  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [151/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REFINE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [152/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REFINE_ADD_NODES  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [153/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REFINE_BOUNDARY  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [154/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REFINE_BOUNDARY_ON_DISTANCE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [155/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REFINE_BOUNDARY_ON_ERROR  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [156/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REFINE_BOUNDARY_ON_THRESHOLD  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [157/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REFINE_ELEMENTS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [158/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REFINE_ELEMENTS_ON_DISTANCE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [159/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REFINE_ELEMENTS_ON_ERROR  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [160/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REFINE_ELEMENTS_ON_THRESHOLD  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [161/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REFINE_INSERT_NODES  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [162/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REFINE_WALL_CORNER  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [163/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REMESH  ,
 
)

Flags related to the meshing parameters

◆ KRATOS_CREATE_LOCAL_FLAG() [164/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REMOVE_BOUNDARY_NODES  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [165/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REMOVE_BOUNDARY_NODES_ON_DISTANCE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [166/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REMOVE_BOUNDARY_NODES_ON_ERROR  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [167/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REMOVE_BOUNDARY_NODES_ON_THRESHOLD  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [168/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REMOVE_NODES  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [169/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REMOVE_NODES_ON_DISTANCE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [170/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REMOVE_NODES_ON_ERROR  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [171/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
REMOVE_NODES_ON_THRESHOLD  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [172/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
SELECT_TESSELLATION_ELEMENTS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [173/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
SET_DOF  ,
10   
)

◆ KRATOS_CREATE_LOCAL_FLAG() [174/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
TRANSFER  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [175/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
TRANSFER_KRATOS_ELEMENTS_TO_MESHER  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [176/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
TRANSFER_KRATOS_FACES_TO_MESHER  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [177/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
TRANSFER_KRATOS_NEIGHBOURS_TO_MESHER  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [178/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
TRANSFER_KRATOS_NODES_TO_MESHER  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [179/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MesherUtilities  ,
VARIABLES_SMOOTHING  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [180/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MeshingFlags  ,
REFINED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [181/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MeshingFlags  ,
TO_COARSEN  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [182/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MeshMovingModeler  ,
TO_COPY  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [183/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MeshNodeCollapsingProcess  ,
TO_COLLAPSE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [184/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ModelPart  ,
ALL_ENTITIES  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [185/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ModelPart  ,
OVERWRITE_ENTITIES  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [186/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MPMUpdatedLagrangian  ,
COMPUTE_LHS_MATRIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [187/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MPMUpdatedLagrangian  ,
COMPUTE_LHS_MATRIX_WITH_COMPONENTS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [188/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MPMUpdatedLagrangian  ,
COMPUTE_RHS_VECTOR  ,
 
)

Flags related to the element computation

◆ KRATOS_CREATE_LOCAL_FLAG() [189/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( MPMUpdatedLagrangian  ,
COMPUTE_RHS_VECTOR_WITH_COMPONENTS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [190/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ParticleFlowRule  ,
IMPLEX_ACTIVE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [191/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ParticleFlowRule  ,
PLASTIC_RATE_REGION  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [192/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ParticleFlowRule  ,
PLASTIC_REGION  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [193/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ParticleFlowRule  ,
RETURN_MAPPING_COMPUTED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [194/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( PointRigidContactCondition  ,
COMPUTE_LHS_MATRIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [195/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( PointRigidContactCondition  ,
COMPUTE_LHS_MATRIX_WITH_COMPONENTS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [196/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( PointRigidContactCondition  ,
COMPUTE_RHS_VECTOR  ,
 
)

Flags related to the condition computation

◆ KRATOS_CREATE_LOCAL_FLAG() [197/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( PointRigidContactCondition  ,
COMPUTE_RHS_VECTOR_WITH_COMPONENTS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [198/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( RigidBodyElement  ,
COMPUTE_LHS_MATRIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [199/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( RigidBodyElement  ,
COMPUTE_RHS_VECTOR  ,
 
)

Flags related to the element computation

◆ KRATOS_CREATE_LOCAL_FLAG() [200/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( RigidBodyPointLinkCondition  ,
COMPUTE_LHS_MATRIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [201/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( RigidBodyPointLinkCondition  ,
COMPUTE_RHS_VECTOR  ,
 
)

Flags related to the condition computation

◆ KRATOS_CREATE_LOCAL_FLAG() [202/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( Serializer  ,
MPI  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [203/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( Serializer  ,
SHALLOW_GLOBAL_POINTERS_SERIALIZATION  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [204/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SmallDisplacementBeamElement3D2N  ,
COMPUTE_LHS_MATRIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [205/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SmallDisplacementBeamElement3D2N  ,
COMPUTE_RHS_VECTOR  ,
 
)

Flags related to the element computation

◆ KRATOS_CREATE_LOCAL_FLAG() [206/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolidElement  ,
COMPUTE_LHS_MATRIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [207/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolidElement  ,
COMPUTE_RHS_VECTOR  ,
 
)

Flags related to the element computation

◆ KRATOS_CREATE_LOCAL_FLAG() [208/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolidElement  ,
FINALIZED_STEP  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [209/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolidShellElementSprism3D6N  ,
COMPUTE_LHS_MATRIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [210/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolidShellElementSprism3D6N  ,
COMPUTE_LHS_MATRIX_WITH_COMPONENTS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [211/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolidShellElementSprism3D6N  ,
COMPUTE_RHS_VECTOR  ,
 
)

Flags related to the element computation

◆ KRATOS_CREATE_LOCAL_FLAG() [212/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolidShellElementSprism3D6N  ,
COMPUTE_RHS_VECTOR_WITH_COMPONENTS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [213/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolidShellElementSprism3D6N  ,
EAS_IMPLICIT_EXPLICIT  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [214/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolidShellElementSprism3D6N  ,
EXPLICIT_RHS_COMPUTATION  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [215/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolidShellElementSprism3D6N  ,
QUADRATIC_ELEMENT  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [216/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolidShellElementSprism3D6N  ,
TOTAL_UPDATED_LAGRANGIAN  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [217/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolverLocalFlags  ,
ADAPTIVE_SOLUTION  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [218/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolverLocalFlags  ,
COMPUTE_REACTIONS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [219/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolverLocalFlags  ,
CONDITIONS_INITIALIZED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [220/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolverLocalFlags  ,
CONSTANT_SYSTEM_MATRIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [221/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolverLocalFlags  ,
CONVERGED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [222/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolverLocalFlags  ,
DOFS_INITIALIZED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [223/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolverLocalFlags  ,
ELEMENTS_INITIALIZED  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [224/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolverLocalFlags  ,
IMPLEX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [225/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolverLocalFlags  ,
INCREMENTAL_SOLUTION  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [226/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolverLocalFlags  ,
INITIALIZED  ,
 
)

Flags for the solution control

◆ KRATOS_CREATE_LOCAL_FLAG() [227/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolverLocalFlags  ,
MOVE_MESH  ,
 
)

Flags for the solution options

◆ KRATOS_CREATE_LOCAL_FLAG() [228/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolverLocalFlags  ,
RAYLEIGH_DAMPING  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [229/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolverLocalFlags  ,
REFORM_DOFS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [230/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( SolverLocalFlags  ,
UPDATE_VARIABLES  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [231/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( TetrahedralMeshOrientationCheck  ,
ALLOW_REPEATED_CONDITIONS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [232/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( TetrahedralMeshOrientationCheck  ,
ASSIGN_NEIGHBOUR_ELEMENTS_TO_CONDITIONS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [233/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( TetrahedralMeshOrientationCheck  ,
COMPUTE_CONDITION_NORMALS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [234/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( TetrahedralMeshOrientationCheck  ,
COMPUTE_NODAL_NORMALS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [235/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( TetrahedralMeshOrientationCheck  ,
MAKE_VOLUMES_POSITIVE  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [236/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ThermalElement  ,
COMPUTE_LHS_MATRIX  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [237/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( ThermalElement  ,
COMPUTE_RHS_VECTOR  ,
 
)

Flags related to the element computation

◆ KRATOS_CREATE_LOCAL_FLAG() [238/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( TimeIntegrationLocalFlags  ,
PREDICT_PRIMARY_VARIABLE  ,
 
)

Flags for the time integration options

◆ KRATOS_CREATE_LOCAL_FLAG() [239/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( VtuOutput  ,
CONDITIONS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [240/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( VtuOutput  ,
ELEMENTS  ,
 
)

◆ KRATOS_CREATE_LOCAL_FLAG() [241/241]

Kratos::KRATOS_CREATE_LOCAL_FLAG ( VtuOutput  ,
NODES  ,
 
)

◆ KRATOS_CREATE_SYMMETRIC_2D_TENSOR_VARIABLE_WITH_COMPONENTS()

Kratos::KRATOS_CREATE_SYMMETRIC_2D_TENSOR_VARIABLE_WITH_COMPONENTS ( METRIC_TENSOR_2D  )

◆ KRATOS_CREATE_SYMMETRIC_3D_TENSOR_VARIABLE_WITH_COMPONENTS() [1/3]

Kratos::KRATOS_CREATE_SYMMETRIC_3D_TENSOR_VARIABLE_WITH_COMPONENTS ( ISOTROPIC_ANISOTROPIC_YIELD_RATIO  )

◆ KRATOS_CREATE_SYMMETRIC_3D_TENSOR_VARIABLE_WITH_COMPONENTS() [2/3]

Kratos::KRATOS_CREATE_SYMMETRIC_3D_TENSOR_VARIABLE_WITH_COMPONENTS ( METRIC_TENSOR_3D  )

◆ KRATOS_CREATE_SYMMETRIC_3D_TENSOR_VARIABLE_WITH_COMPONENTS() [3/3]

Kratos::KRATOS_CREATE_SYMMETRIC_3D_TENSOR_VARIABLE_WITH_COMPONENTS ( ORTHOTROPIC_ELASTIC_CONSTANTS  )

◆ KRATOS_CREATE_VARIABLE() [1/198]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED Kratos::KRATOS_CREATE_VARIABLE ( bool  ,
ACTIVE_SET_CONVERGED   
)

◆ KRATOS_CREATE_VARIABLE() [2/198]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT LAGRANGE_MULTIPLIER_CONTACT_PRESSURE CONSIDER_NORMAL_VARIATION Kratos::KRATOS_CREATE_VARIABLE ( bool  ,
ADAPT_PENALTY   
)

◆ KRATOS_CREATE_VARIABLE() [3/198]

Kratos::KRATOS_CREATE_VARIABLE ( bool  ,
ADVANCE_STRATEGY_APPLIED   
)

◆ KRATOS_CREATE_VARIABLE() [4/198]

Kratos::KRATOS_CREATE_VARIABLE ( bool  ,
CHIMERA_INTERNAL_BOUNDARY   
)

◆ KRATOS_CREATE_VARIABLE() [5/198]

Kratos::KRATOS_CREATE_VARIABLE ( bool  ,
COMPUTE_CONTROL_DENSITIES   
)

◆ KRATOS_CREATE_VARIABLE() [6/198]

Kratos::KRATOS_CREATE_VARIABLE ( bool  ,
COMPUTE_CONTROL_POINTS_SHAPE   
)

◆ KRATOS_CREATE_VARIABLE() [7/198]

Kratos::KRATOS_CREATE_VARIABLE ( bool  ,
COMPUTE_HELMHOLTZ_INVERSE   
)

◆ KRATOS_CREATE_VARIABLE() [8/198]

Kratos::KRATOS_CREATE_VARIABLE ( bool  ,
CONSIDER_FACE_ANGLE   
)

◆ KRATOS_CREATE_VARIABLE() [9/198]

Kratos::KRATOS_CREATE_VARIABLE ( bool  ,
CONSIDER_IMPLICIT_EAS_SPRISM_ELEMENT   
)

◆ KRATOS_CREATE_VARIABLE() [10/198]

Kratos::KRATOS_CREATE_VARIABLE ( bool  ,
CONSIDER_QUADRATIC_SPRISM_ELEMENT   
)

◆ KRATOS_CREATE_VARIABLE() [11/198]

REACTION_CHECK_STIFFNESS_FACTOR Kratos::KRATOS_CREATE_VARIABLE ( bool  ,
CONSIDER_TESSELLATION   
)

◆ KRATOS_CREATE_VARIABLE() [12/198]

Kratos::KRATOS_CREATE_VARIABLE ( bool  ,
CONSIDER_TOTAL_LAGRANGIAN_SPRISM_ELEMENT   
)

◆ KRATOS_CREATE_VARIABLE() [13/198]

Kratos::KRATOS_CREATE_VARIABLE ( bool  ,
HELMHOLTZ_INTEGRATED_FIELD   
)

◆ KRATOS_CREATE_VARIABLE() [14/198]

Kratos::KRATOS_CREATE_VARIABLE ( bool  ,
IS_ADJOINT   
)

◆ KRATOS_CREATE_VARIABLE() [15/198]

Kratos::KRATOS_CREATE_VARIABLE ( bool  ,
PURE_EXPLICIT_RHS_COMPUTATION   
)

◆ KRATOS_CREATE_VARIABLE() [16/198]

Kratos::KRATOS_CREATE_VARIABLE ( bool  ,
RESET_EQUATION_IDS   
)

◆ KRATOS_CREATE_VARIABLE() [17/198]

Kratos::KRATOS_CREATE_VARIABLE ( bool  ,
SYMMETRIZE_TANGENT_OPERATOR   
)

◆ KRATOS_CREATE_VARIABLE() [18/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
ACUMULATED_PLASTIC_STRAIN   
)

◆ KRATOS_CREATE_VARIABLE() [19/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
ALPHA   
)

◆ KRATOS_CREATE_VARIABLE() [20/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
ALPHA_EAS   
)

◆ KRATOS_CREATE_VARIABLE() [21/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
ALPHA_MAPPED   
)

◆ KRATOS_CREATE_VARIABLE() [22/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
ANG_ROT   
)

◆ KRATOS_CREATE_VARIABLE() [23/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
ANISOTROPIC_RATIO   
)

◆ KRATOS_CREATE_VARIABLE() [24/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
AREA_EFFECTIVE_Y_SENSITIVITY   
)

◆ KRATOS_CREATE_VARIABLE() [25/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
AREA_EFFECTIVE_Z_SENSITIVITY   
)

◆ KRATOS_CREATE_VARIABLE() [26/198]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT LAGRANGE_MULTIPLIER_CONTACT_PRESSURE Kratos::KRATOS_CREATE_VARIABLE ( double  ,
AUGMENTED_NORMAL_CONTACT_PRESSURE   
)

◆ KRATOS_CREATE_VARIABLE() [27/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
AVERAGE_NODAL_ERROR   
)

◆ KRATOS_CREATE_VARIABLE() [28/198]

PARTICLE_COHESION I33 Kratos::KRATOS_CREATE_VARIABLE ( double  ,
BEAM_INERTIA_ROT_UNIT_LENGHT_X   
)

◆ KRATOS_CREATE_VARIABLE() [29/198]

PARTICLE_COHESION I33 BEAM_INERTIA_ROT_UNIT_LENGHT_Y KRATOS_CREATE_VARIABLE (double, BEAM_INERTIA_ROT_UNIT_LENGHT_Z) typedef std K_ALPHA NEIGHBOUR_PARTICLE_OF_RIGID_FACE Kratos::KRATOS_CREATE_VARIABLE ( double  ,
CALCULATE_COMPUTE_NEW_RIGID_FACE_NEIGHBOURS_HISTORICAL_DATA   
)

◆ KRATOS_CREATE_VARIABLE() [30/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
CD   
)

◆ KRATOS_CREATE_VARIABLE() [31/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
CHIMERA_DISTANCE   
)

◆ KRATOS_CREATE_VARIABLE() [32/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
CROSS_AREA   
)

◆ KRATOS_CREATE_VARIABLE() [33/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
CROSS_AREA_SENSITIVITY   
)

◆ KRATOS_CREATE_VARIABLE() [34/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
CT   
)

◆ KRATOS_CREATE_VARIABLE() [35/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_CD   
)

◆ KRATOS_CREATE_VARIABLE() [36/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_CT   
)

◆ KRATOS_CREATE_VARIABLE() [37/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_INTERFACE_D_CD   
)

◆ KRATOS_CREATE_VARIABLE() [38/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_INTERFACE_D_FD   
)

◆ KRATOS_CREATE_VARIABLE() [39/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_MASS_D_CD   
)

◆ KRATOS_CREATE_VARIABLE() [40/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_MASS_D_CT   
)

◆ KRATOS_CREATE_VARIABLE() [41/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_MASS_D_FD   
)

◆ KRATOS_CREATE_VARIABLE() [42/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_MASS_D_FT   
)

◆ KRATOS_CREATE_VARIABLE() [43/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_MASS_D_PD   
)

◆ KRATOS_CREATE_VARIABLE() [44/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_PARTITION_MASS_D_CD   
)

◆ KRATOS_CREATE_VARIABLE() [45/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_PARTITION_MASS_D_FD   
)

◆ KRATOS_CREATE_VARIABLE() [46/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_PD   
)

◆ KRATOS_CREATE_VARIABLE() [47/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_PD_D_FD   
)

◆ KRATOS_CREATE_VARIABLE() [48/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_PE_D_FD   
)

◆ KRATOS_CREATE_VARIABLE() [49/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_PPT_D_FT   
)

◆ KRATOS_CREATE_VARIABLE() [50/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_PT   
)

◆ KRATOS_CREATE_VARIABLE() [51/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_PT_D_FT   
)

◆ KRATOS_CREATE_VARIABLE() [52/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_STRAIN_ENERGY_1_D_CD   
)

◆ KRATOS_CREATE_VARIABLE() [53/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_STRAIN_ENERGY_1_D_CT   
)

◆ KRATOS_CREATE_VARIABLE() [54/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_STRAIN_ENERGY_1_D_FD   
)

◆ KRATOS_CREATE_VARIABLE() [55/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_STRAIN_ENERGY_1_D_FT   
)

◆ KRATOS_CREATE_VARIABLE() [56/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_STRAIN_ENERGY_2_D_CD   
)

◆ KRATOS_CREATE_VARIABLE() [57/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_STRAIN_ENERGY_2_D_CT   
)

◆ KRATOS_CREATE_VARIABLE() [58/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_STRAIN_ENERGY_2_D_FD   
)

◆ KRATOS_CREATE_VARIABLE() [59/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_STRAIN_ENERGY_2_D_FT   
)

◆ KRATOS_CREATE_VARIABLE() [60/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_STRAIN_ENERGY_3_D_CD   
)

◆ KRATOS_CREATE_VARIABLE() [61/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_STRAIN_ENERGY_3_D_CT   
)

◆ KRATOS_CREATE_VARIABLE() [62/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_STRAIN_ENERGY_3_D_FD   
)

◆ KRATOS_CREATE_VARIABLE() [63/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_STRAIN_ENERGY_3_D_FT   
)

◆ KRATOS_CREATE_VARIABLE() [64/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_STRESS_D_CD   
)

◆ KRATOS_CREATE_VARIABLE() [65/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
D_STRESS_D_FD   
)

◆ KRATOS_CREATE_VARIABLE() [66/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
DENSITY_FIBER   
)

◆ KRATOS_CREATE_VARIABLE() [67/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
DENSITY_SENSITIVITY   
)

◆ KRATOS_CREATE_VARIABLE() [68/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
DF1DALPHA   
)

◆ KRATOS_CREATE_VARIABLE() [69/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
DF1DALPHA_MAPPED   
)

◆ KRATOS_CREATE_VARIABLE() [70/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
DF1DALPHA_WEIGHTED   
)

◆ KRATOS_CREATE_VARIABLE() [71/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
DF1DALPHA_WEIGHTED_MAPPED   
)

◆ KRATOS_CREATE_VARIABLE() [72/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
DLDALPHA   
)

◆ KRATOS_CREATE_VARIABLE() [73/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
DPDALPHA   
)

◆ KRATOS_CREATE_VARIABLE() [74/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
DPDALPHA_MAPPED   
)

◆ KRATOS_CREATE_VARIABLE() [75/198]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT Kratos::KRATOS_CREATE_VARIABLE ( double  ,
DYNAMIC_FACTOR   
)

◆ KRATOS_CREATE_VARIABLE() [76/198]

TWSS Kratos::KRATOS_CREATE_VARIABLE ( double  ,
ECAP   
)

◆ KRATOS_CREATE_VARIABLE() [77/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
ELEMENT_STRAIN_ENERGY   
)

◆ KRATOS_CREATE_VARIABLE() [78/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
EQUIVALENT_STRESS_VM   
)

◆ KRATOS_CREATE_VARIABLE() [79/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
FD   
)

◆ KRATOS_CREATE_VARIABLE() [80/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
FIBER_VOLUMETRIC_PART   
)

◆ KRATOS_CREATE_VARIABLE() [81/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
FICTITIOUS_FLUID_DENSITY   
)

◆ KRATOS_CREATE_VARIABLE() [82/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
FRACTURE_ENERGY_FIBER   
)

◆ KRATOS_CREATE_VARIABLE() [83/198]

PARTICLE_COHESION I33 BEAM_INERTIA_ROT_UNIT_LENGHT_Y KRATOS_CREATE_VARIABLE (double, BEAM_INERTIA_ROT_UNIT_LENGHT_Z) typedef std Kratos::KRATOS_CREATE_VARIABLE ( double  ,
FRICTION   
)

◆ KRATOS_CREATE_VARIABLE() [84/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
FSI_INTERFACE_MESH_RESIDUAL_NORM   
)

◆ KRATOS_CREATE_VARIABLE() [85/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
FSI_INTERFACE_RESIDUAL_NORM   
)

◆ KRATOS_CREATE_VARIABLE() [86/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
FT   
)

◆ KRATOS_CREATE_VARIABLE() [87/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
GAUSSIAN_CURVATURE   
)

◆ KRATOS_CREATE_VARIABLE() [88/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
HEATMAP_DF1DALPHA   
)

◆ KRATOS_CREATE_VARIABLE() [89/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
HEATMAP_L2   
)

◆ KRATOS_CREATE_VARIABLE() [90/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
HEATMAP_MAX   
)

◆ KRATOS_CREATE_VARIABLE() [91/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
HELMHOLTZ_BULK_POISSON_RATIO_SHAPE   
)

◆ KRATOS_CREATE_VARIABLE() [92/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
HELMHOLTZ_BULK_RADIUS_SHAPE   
)

◆ KRATOS_CREATE_VARIABLE() [93/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
HELMHOLTZ_RADIUS   
)

◆ KRATOS_CREATE_VARIABLE() [94/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
HELMHOLTZ_RADIUS_DENSITY   
)

◆ KRATOS_CREATE_VARIABLE() [95/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
HELMHOLTZ_RADIUS_THICKNESS   
)

◆ KRATOS_CREATE_VARIABLE() [96/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
HELMHOLTZ_SCALAR   
)

◆ KRATOS_CREATE_VARIABLE() [97/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
HELMHOLTZ_SCALAR_SOURCE   
)

◆ KRATOS_CREATE_VARIABLE() [98/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
HELMHOLTZ_SOURCE_DENSITY   
)

◆ KRATOS_CREATE_VARIABLE() [99/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
HELMHOLTZ_SOURCE_THICKNESS   
)

◆ KRATOS_CREATE_VARIABLE() [100/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
HELMHOLTZ_SURF_POISSON_RATIO_SHAPE   
)

◆ KRATOS_CREATE_VARIABLE() [101/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
HELMHOLTZ_SURF_RADIUS_SHAPE   
)

◆ KRATOS_CREATE_VARIABLE() [102/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
HELMHOLTZ_VAR_DENSITY   
)

◆ KRATOS_CREATE_VARIABLE() [103/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
HELMHOLTZ_VAR_THICKNESS   
)

◆ KRATOS_CREATE_VARIABLE() [104/198]

PARTICLE_COHESION Kratos::KRATOS_CREATE_VARIABLE ( double  ,
I22   
)

◆ KRATOS_CREATE_VARIABLE() [105/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
I22_SENSITIVITY   
)

◆ KRATOS_CREATE_VARIABLE() [106/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
I33_SENSITIVITY   
)

◆ KRATOS_CREATE_VARIABLE() [107/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
INV_HESSIAN   
)

◆ KRATOS_CREATE_VARIABLE() [108/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
MAPPER_SCALAR_PROJECTION_RHS   
)

◆ KRATOS_CREATE_VARIABLE() [109/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
MAX_NEIGHBOUR_DISTANCE   
)

◆ KRATOS_CREATE_VARIABLE() [110/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
MAX_PLASTIC_STRAIN   
)

◆ KRATOS_CREATE_VARIABLE() [111/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
METRIC_SCALAR   
)

◆ KRATOS_CREATE_VARIABLE() [112/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
NEAREST_NEIGHBOUR_DIST   
)

◆ KRATOS_CREATE_VARIABLE() [113/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
OLD_RELAXED_SCALAR   
)

◆ KRATOS_CREATE_VARIABLE() [114/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
OLD_RELAXED_SCALAR_TRACTION   
)

◆ KRATOS_CREATE_VARIABLE() [115/198]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED Kratos::KRATOS_CREATE_VARIABLE ( double  ,
OPERATOR_THRESHOLD   
)

◆ KRATOS_CREATE_VARIABLE() [116/198]

TWSS RRT Kratos::KRATOS_CREATE_VARIABLE ( double  ,
OSI   
)

◆ KRATOS_CREATE_VARIABLE() [117/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
PD   
)

◆ KRATOS_CREATE_VARIABLE() [118/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
PE   
)

◆ KRATOS_CREATE_VARIABLE() [119/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
PLASTIC_UNIAXIAL_STRESS   
)

◆ KRATOS_CREATE_VARIABLE() [120/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
POISSON_RATIO_FIBER   
)

◆ KRATOS_CREATE_VARIABLE() [121/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
POISSON_RATIO_SENSITIVITY   
)

◆ KRATOS_CREATE_VARIABLE() [122/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
PPT   
)

◆ KRATOS_CREATE_VARIABLE() [123/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
PRESS_DISCONTINUITY   
)

◆ KRATOS_CREATE_VARIABLE() [124/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
PREVIOUS_CYCLE   
)

◆ KRATOS_CREATE_VARIABLE() [125/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
PT   
)

◆ KRATOS_CREATE_VARIABLE() [126/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
REFERENCE_DEFORMATION_GRADIENT_DETERMINANT   
)

◆ KRATOS_CREATE_VARIABLE() [127/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
RELAXED_SCALAR   
)

◆ KRATOS_CREATE_VARIABLE() [128/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
RELAXED_SCALAR_TRACTION   
)

◆ KRATOS_CREATE_VARIABLE() [129/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
ROTATION_ANGLE   
)

◆ KRATOS_CREATE_VARIABLE() [130/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
ROTATIONAL_ANGLE   
)

◆ KRATOS_CREATE_VARIABLE() [131/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
ROTATIONAL_VELOCITY   
)

◆ KRATOS_CREATE_VARIABLE() [132/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
SCALAR_DISPLACEMENT   
)

◆ KRATOS_CREATE_VARIABLE() [133/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
SCALAR_FORCE   
)

◆ KRATOS_CREATE_VARIABLE() [134/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
SCALAR_INTERFACE_RESIDUAL   
)

◆ KRATOS_CREATE_VARIABLE() [135/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
SCALAR_PROJECTED   
)

◆ KRATOS_CREATE_VARIABLE() [136/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
SCALAR_REACTION   
)

◆ KRATOS_CREATE_VARIABLE() [137/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
SCALAR_ROOT_POINT_DISPLACEMENT   
)

◆ KRATOS_CREATE_VARIABLE() [138/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
SCALAR_TRACTION_INTERFACE_RESIDUAL   
)

◆ KRATOS_CREATE_VARIABLE() [139/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
SCALAR_VARIABLE   
)

◆ KRATOS_CREATE_VARIABLE() [140/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
SCALAR_VARIABLE_MAPPED   
)

◆ KRATOS_CREATE_VARIABLE() [141/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
SCALAR_VOLUME_ACCELERATION   
)

◆ KRATOS_CREATE_VARIABLE() [142/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
SERIAL_PARALLEL_EQUILIBRIUM_TOLERANCE   
)

◆ KRATOS_CREATE_VARIABLE() [143/198]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR Kratos::KRATOS_CREATE_VARIABLE ( double  ,
SLIP_THRESHOLD   
)

◆ KRATOS_CREATE_VARIABLE() [144/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
TAWSS   
)

◆ KRATOS_CREATE_VARIABLE() [145/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
TEMPORARY_SCALAR_VARIABLE_1   
)

◆ KRATOS_CREATE_VARIABLE() [146/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
TEMPORARY_SCALAR_VARIABLE_2   
)

◆ KRATOS_CREATE_VARIABLE() [147/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
THICKNESS_SENSITIVITY   
)

◆ KRATOS_CREATE_VARIABLE() [148/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
VERTEX_MORPHING_RADIUS   
)

◆ KRATOS_CREATE_VARIABLE() [149/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
VERTEX_MORPHING_RADIUS_RAW   
)

◆ KRATOS_CREATE_VARIABLE() [150/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
WAKE_DISTANCE   
)

◆ KRATOS_CREATE_VARIABLE() [151/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
YIELD_STRESS_C_FIBER   
)

◆ KRATOS_CREATE_VARIABLE() [152/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
YIELD_STRESS_T_FIBER   
)

◆ KRATOS_CREATE_VARIABLE() [153/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
YOUNG_MODULUS_FIBER   
)

◆ KRATOS_CREATE_VARIABLE() [154/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
YOUNG_MODULUS_SENSITIVITY   
)

◆ KRATOS_CREATE_VARIABLE() [155/198]

Kratos::KRATOS_CREATE_VARIABLE ( double  ,
Ypr   
)

◆ KRATOS_CREATE_VARIABLE() [156/198]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD Kratos::KRATOS_CREATE_VARIABLE ( double  ,
ZERO_TOLERANCE_FACTOR   
)

◆ KRATOS_CREATE_VARIABLE() [157/198]

PARTICLE_COHESION I33 BEAM_INERTIA_ROT_UNIT_LENGHT_Y KRATOS_CREATE_VARIABLE (double, BEAM_INERTIA_ROT_UNIT_LENGHT_Z) typedef std K_ALPHA Kratos::KRATOS_CREATE_VARIABLE ( GlobalPointersVector< Element ,
NEIGHBOUR_PARTICLE_BLOCK_ELEMENTS   
)

◆ KRATOS_CREATE_VARIABLE() [158/198]

Kratos::KRATOS_CREATE_VARIABLE ( IndexSet::Pointer  ,
INDEX_SET   
)

◆ KRATOS_CREATE_VARIABLE() [159/198]

Kratos::KRATOS_CREATE_VARIABLE ( int  ,
CONVERGENCE_ACCELERATOR_ITERATION   
)

◆ KRATOS_CREATE_VARIABLE() [160/198]

Kratos::KRATOS_CREATE_VARIABLE ( int  ,
COUPLING_ITERATION_NUMBER   
)

◆ KRATOS_CREATE_VARIABLE() [161/198]

Kratos::KRATOS_CREATE_VARIABLE ( int  ,
EXPLICIT_EQUATION_ID   
)

◆ KRATOS_CREATE_VARIABLE() [162/198]

Kratos::KRATOS_CREATE_VARIABLE ( int  ,
HARDENING_LAW   
)

◆ KRATOS_CREATE_VARIABLE() [163/198]

Kratos::KRATOS_CREATE_VARIABLE ( int  ,
INTEGRATION_ORDER   
)

◆ KRATOS_CREATE_VARIABLE() [164/198]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION Kratos::KRATOS_CREATE_VARIABLE ( int  ,
INTEGRATION_ORDER_CONTACT   
)

◆ KRATOS_CREATE_VARIABLE() [165/198]

Kratos::KRATOS_CREATE_VARIABLE ( int  ,
INTERFACE_EQUATION_ID   
)

◆ KRATOS_CREATE_VARIABLE() [166/198]

Kratos::KRATOS_CREATE_VARIABLE ( int  ,
MAPPING_ID   
)

◆ KRATOS_CREATE_VARIABLE() [167/198]

Kratos::KRATOS_CREATE_VARIABLE ( int  ,
NEAREST_NEIGHBOUR_COND_ID   
)

◆ KRATOS_CREATE_VARIABLE() [168/198]

Kratos::KRATOS_CREATE_VARIABLE ( int  ,
TRACED_STRESS_TYPE   
)

◆ KRATOS_CREATE_VARIABLE() [169/198]

Kratos::KRATOS_CREATE_VARIABLE ( MasterSlaveConstraint::Pointer  ,
CONSTRAINT_POINTER   
)

◆ KRATOS_CREATE_VARIABLE() [170/198]

Kratos::KRATOS_CREATE_VARIABLE ( Matrix  ,
BIOT_STRAIN_TENSOR   
)

◆ KRATOS_CREATE_VARIABLE() [171/198]

Kratos::KRATOS_CREATE_VARIABLE ( Matrix  ,
FIBER_STRESS_TENSOR   
)

◆ KRATOS_CREATE_VARIABLE() [172/198]

Kratos::KRATOS_CREATE_VARIABLE ( Matrix  ,
HELMHOLTZ_MASS_MATRIX   
)

◆ KRATOS_CREATE_VARIABLE() [173/198]

Kratos::KRATOS_CREATE_VARIABLE ( Matrix  ,
HENCKY_STRAIN_TENSOR   
)

◆ KRATOS_CREATE_VARIABLE() [174/198]

Kratos::KRATOS_CREATE_VARIABLE ( Matrix  ,
MATRIX_STRESS_TENSOR   
)

◆ KRATOS_CREATE_VARIABLE() [175/198]

Kratos::KRATOS_CREATE_VARIABLE ( Matrix  ,
MATRIX_STRESS_TENSOR_INTEGRATED   
)

◆ KRATOS_CREATE_VARIABLE() [176/198]

Kratos::KRATOS_CREATE_VARIABLE ( Matrix  ,
REFERENCE_DEFORMATION_GRADIENT   
)

◆ KRATOS_CREATE_VARIABLE() [177/198]

Kratos::KRATOS_CREATE_VARIABLE ( Matrix  ,
STRAIN_TENSOR   
)

◆ KRATOS_CREATE_VARIABLE() [178/198]

Kratos::KRATOS_CREATE_VARIABLE ( Matrix  ,
STRESS_DESIGN_DERIVATIVE_ON_GP   
)

◆ KRATOS_CREATE_VARIABLE() [179/198]

Kratos::KRATOS_CREATE_VARIABLE ( Matrix  ,
STRESS_DESIGN_DERIVATIVE_ON_NODE   
)

◆ KRATOS_CREATE_VARIABLE() [180/198]

Kratos::KRATOS_CREATE_VARIABLE ( Matrix  ,
STRESS_DISP_DERIV_ON_GP   
)

◆ KRATOS_CREATE_VARIABLE() [181/198]

Kratos::KRATOS_CREATE_VARIABLE ( Matrix  ,
STRESS_DISP_DERIV_ON_NODE   
)

◆ KRATOS_CREATE_VARIABLE() [182/198]

Kratos::KRATOS_CREATE_VARIABLE ( Matrix  ,
STRESS_TENSOR   
)

◆ KRATOS_CREATE_VARIABLE() [183/198]

Kratos::KRATOS_CREATE_VARIABLE ( Matrix  ,
STRESS_TENSOR_INTEGRATED   
)

◆ KRATOS_CREATE_VARIABLE() [184/198]

Kratos::KRATOS_CREATE_VARIABLE ( std::string  ,
DESIGN_VARIABLE_NAME   
)

◆ KRATOS_CREATE_VARIABLE() [185/198]

Kratos::KRATOS_CREATE_VARIABLE ( std::string  ,
UDSM_NAME   
)

◆ KRATOS_CREATE_VARIABLE() [186/198]

Kratos::KRATOS_CREATE_VARIABLE ( std::vector< std::size_t >  ,
ELEMENTS_ID_INDEX_MAP   
)

◆ KRATOS_CREATE_VARIABLE() [187/198]

Kratos::KRATOS_CREATE_VARIABLE ( std::vector< std::size_t >  ,
NODES_ID_INDEX_MAP   
)

◆ KRATOS_CREATE_VARIABLE() [188/198]

Kratos::KRATOS_CREATE_VARIABLE ( std::vector< std::string >  ,
MODEL_PART_STATUS   
)

◆ KRATOS_CREATE_VARIABLE() [189/198]

Kratos::KRATOS_CREATE_VARIABLE ( Vector  ,
AUXILIAR_HESSIAN   
)

◆ KRATOS_CREATE_VARIABLE() [190/198]

Kratos::KRATOS_CREATE_VARIABLE ( Vector  ,
BIOT_STRAIN_VECTOR   
)

◆ KRATOS_CREATE_VARIABLE() [191/198]

Kratos::KRATOS_CREATE_VARIABLE ( Vector  ,
FIBER_STRESS_VECTOR   
)

◆ KRATOS_CREATE_VARIABLE() [192/198]

Kratos::KRATOS_CREATE_VARIABLE ( Vector  ,
HENCKY_STRAIN_VECTOR   
)

◆ KRATOS_CREATE_VARIABLE() [193/198]

Kratos::KRATOS_CREATE_VARIABLE ( Vector  ,
MATRIX_STRESS_VECTOR   
)

◆ KRATOS_CREATE_VARIABLE() [194/198]

Kratos::KRATOS_CREATE_VARIABLE ( Vector  ,
STRESS_ON_GP   
)

◆ KRATOS_CREATE_VARIABLE() [195/198]

Kratos::KRATOS_CREATE_VARIABLE ( Vector  ,
STRESS_ON_NODE   
)

◆ KRATOS_CREATE_VARIABLE() [196/198]

Kratos::KRATOS_CREATE_VARIABLE ( Vector  ,
WAKE_ELEMENTAL_DISTANCES   
)

◆ KRATOS_CREATE_VARIABLE() [197/198]

Kratos::KRATOS_CREATE_VARIABLE ( Vector  ,
WAKE_ORIGIN   
)

◆ KRATOS_CREATE_VARIABLE() [198/198]

Kratos::KRATOS_CREATE_VARIABLE ( Vector3  ,
AUXILIAR_GRADIENT   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [1/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( CHIMERA_APPLICATION  ,
ROTATION_MESH_DISPLACEMENT   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [2/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( CHIMERA_APPLICATION  ,
ROTATION_MESH_VELOCITY   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [3/50]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( CONTACT_STRUCTURAL_MECHANICS_APPLICATION  ,
DELTA_COORDINATES   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [4/50]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( CONTACT_STRUCTURAL_MECHANICS_APPLICATION  ,
TANGENT_SLIP   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [5/50]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( CONTACT_STRUCTURAL_MECHANICS_APPLICATION  ,
WEIGHTED_SLIP   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [6/50]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( CONTACT_STRUCTURAL_MECHANICS_APPLICATION  ,
WEIGHTED_VECTOR_RESIDUAL   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [7/50]

TABLE_NUMBER_ANGULAR_VELOCITY Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( DEM_APPLICATION  ,
TABLE_NUMBER_FORCE   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [8/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( DEM_APPLICATION  ,
TABLE_NUMBER_VELOCITY   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [9/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( FEM_TO_DEM_APPLICATION  ,
AUXILIAR_GRADIENT   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [10/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( FEM_TO_DEM_APPLICATION  ,
EQUIVALENT_NODAL_STRESS_GRADIENT   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [11/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( FEM_TO_DEM_APPLICATION  ,
FORCE_LOAD   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [12/50]

TWSS RRT WSS WSS_TANGENTIAL_STRESS TEMPORAL_OSI Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( FLUID_DYNAMICS_BIOMEDICAL_APPLICATION  ,
WALL_NORMAL   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [13/50]

TWSS RRT WSS WSS_TANGENTIAL_STRESS Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( FLUID_DYNAMICS_BIOMEDICAL_APPLICATION  ,
WSS_NORMAL_STRESS   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [14/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
ADJOINT_RHS   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [15/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
AUXILIARY_FIELD   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [16/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
CX   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [17/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_CX   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [18/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_LINEAR_D_CX   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [19/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_LINEAR_D_X   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [20/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_MASS_D_CX   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [21/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_MASS_D_X   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [22/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_MAX_OVERHANG_ANGLE_D_CX   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [23/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_MAX_OVERHANG_ANGLE_D_X   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [24/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_MAX_STRES_D_CX   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [25/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_MAX_STRES_D_X   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [26/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_MAX_STRESS_D_CX   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [27/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_MAX_STRESS_D_X   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [28/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_PLANE_SYMMETRY_D_CX   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [29/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_PLANE_SYMMETRY_D_X   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [30/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_STRAIN_ENERGY_1_D_CX   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [31/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_STRAIN_ENERGY_1_D_X   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [32/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_STRAIN_ENERGY_2_D_CX   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [33/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_STRAIN_ENERGY_2_D_X   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [34/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_STRAIN_ENERGY_3_D_CX   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [35/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_STRAIN_ENERGY_3_D_X   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [36/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_STRESS_D_CX   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [37/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_STRESS_D_X   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [38/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
D_X   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [39/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
HELMHOLTZ_SOURCE_SHAPE   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [40/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
HELMHOLTZ_VARS_SHAPE   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [41/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
HELMHOLTZ_VECTOR   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [42/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
HELMHOLTZ_VECTOR_SOURCE   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [43/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
NEAREST_NEIGHBOUR_POINT   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [44/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
SHAPE   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [45/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
SX   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [46/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
TEMPORARY_ARRAY3_VARIABLE_1   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [47/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( OPTIMIZATION_APPLICATION  ,
TEMPORARY_ARRAY3_VARIABLE_2   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [48/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( STRUCTURAL_MECHANICS_APPLICATION  ,
NODAL_DISPLACEMENT_STIFFNESS_SENSITIVITY   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [49/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( STRUCTURAL_MECHANICS_APPLICATION  ,
NODAL_ROTATIONAL_STIFFNESS_SENSITIVITY   
)

◆ KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS() [50/50]

Kratos::KRATOS_DEFINE_3D_APPLICATION_VARIABLE_WITH_COMPONENTS ( STRUCTURAL_MECHANICS_APPLICATION  ,
POINT_LOAD_SENSITIVITY   
)

◆ KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS() [1/4]

Kratos::KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS ( MESH_ACCELERATION  )

◆ KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS() [2/4]

Kratos::KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS ( MESH_DISPLACEMENT  )

◆ KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS() [3/4]

Kratos::KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS ( MESH_REACTION  )

◆ KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS() [4/4]

Kratos::KRATOS_DEFINE_3D_VARIABLE_WITH_COMPONENTS ( MESH_RHS  )

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [1/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CHIMERA_APPLICATION  ,
bool  ,
CHIMERA_INTERNAL_BOUNDARY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [2/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CHIMERA_APPLICATION  ,
double  ,
CHIMERA_DISTANCE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [3/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CHIMERA_APPLICATION  ,
double  ,
ROTATIONAL_ANGLE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [4/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CHIMERA_APPLICATION  ,
double  ,
ROTATIONAL_VELOCITY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [5/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CO_SIMULATION_APPLICATION  ,
double  ,
SCALAR_DISPLACEMENT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [6/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CO_SIMULATION_APPLICATION  ,
double  ,
SCALAR_FORCE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [7/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CO_SIMULATION_APPLICATION  ,
double  ,
SCALAR_REACTION   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [8/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CO_SIMULATION_APPLICATION  ,
double  ,
SCALAR_ROOT_POINT_DISPLACEMENT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [9/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CO_SIMULATION_APPLICATION  ,
double  ,
SCALAR_VOLUME_ACCELERATION   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [10/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CO_SIMULATION_APPLICATION  ,
int  ,
COUPLING_ITERATION_NUMBER   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [11/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CO_SIMULATION_APPLICATION  ,
int  ,
EXPLICIT_EQUATION_ID   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [12/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CO_SIMULATION_APPLICATION  ,
int  ,
INTERFACE_EQUATION_ID   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [13/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CO_SIMULATION_APPLICATION  ,
std::vector< std::size_t >  ,
ELEMENTS_ID_INDEX_MAP   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [14/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CO_SIMULATION_APPLICATION  ,
std::vector< std::size_t >  ,
NODES_ID_INDEX_MAP   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [15/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONSTITUTIVE_LAWS_APPLICATION  ,
bool  ,
ADVANCE_STRATEGY_APPLIED   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [16/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONSTITUTIVE_LAWS_APPLICATION  ,
bool  ,
SYMMETRIZE_TANGENT_OPERATOR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [17/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONSTITUTIVE_LAWS_APPLICATION  ,
double  ,
PLASTIC_DAMAGE_PROPORTION   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [18/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONSTITUTIVE_LAWS_APPLICATION  ,
double  ,
PREVIOUS_CYCLE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [19/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONSTITUTIVE_LAWS_APPLICATION  ,
double  ,
SERIAL_PARALLEL_EQUILIBRIUM_TOLERANCE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [20/210]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONTACT_STRUCTURAL_MECHANICS_APPLICATION  ,
bool  ,
ACTIVE_SET_CONVERGED   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [21/210]

REACTION_CHECK_STIFFNESS_FACTOR Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONTACT_STRUCTURAL_MECHANICS_APPLICATION  ,
bool  ,
CONSIDER_TESSELLATION   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [22/210]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT LAGRANGE_MULTIPLIER_CONTACT_PRESSURE Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONTACT_STRUCTURAL_MECHANICS_APPLICATION  ,
double  ,
AUGMENTED_NORMAL_CONTACT_PRESSURE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [23/210]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONTACT_STRUCTURAL_MECHANICS_APPLICATION  ,
double  ,
DYNAMIC_FACTOR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [24/210]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT LAGRANGE_MULTIPLIER_CONTACT_PRESSURE AUGMENTED_TANGENT_CONTACT_PRESSURE ADAPT_PENALTY Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONTACT_STRUCTURAL_MECHANICS_APPLICATION  ,
double  ,
MAX_GAP_FACTOR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [25/210]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONTACT_STRUCTURAL_MECHANICS_APPLICATION  ,
double  ,
OPERATOR_THRESHOLD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [26/210]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONTACT_STRUCTURAL_MECHANICS_APPLICATION  ,
double  ,
SLIP_THRESHOLD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [27/210]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONTACT_STRUCTURAL_MECHANICS_APPLICATION  ,
double  ,
ZERO_TOLERANCE_FACTOR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [28/210]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT LAGRANGE_MULTIPLIER_CONTACT_PRESSURE AUGMENTED_TANGENT_CONTACT_PRESSURE ADAPT_PENALTY TYING_VARIABLE Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONTACT_STRUCTURAL_MECHANICS_APPLICATION  ,
Element::Pointer  ,
PARENT_ELEMENT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [29/210]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT LAGRANGE_MULTIPLIER_CONTACT_PRESSURE AUGMENTED_TANGENT_CONTACT_PRESSURE ADAPT_PENALTY TYING_VARIABLE MAX_GAP_THRESHOLD Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONTACT_STRUCTURAL_MECHANICS_APPLICATION  ,
FrictionalLaw::Pointer  ,
FRICTIONAL_LAW   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [30/210]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT LAGRANGE_MULTIPLIER_CONTACT_PRESSURE AUGMENTED_TANGENT_CONTACT_PRESSURE Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONTACT_STRUCTURAL_MECHANICS_APPLICATION  ,
int  ,
CONSIDER_NORMAL_VARIATION   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [31/210]

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONTACT_STRUCTURAL_MECHANICS_APPLICATION  ,
int  ,
INTEGRATION_ORDER_CONTACT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [32/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( CONTACT_STRUCTURAL_MECHANICS_APPLICATION  ,
MasterSlaveConstraint::Pointer  ,
CONSTRAINT_POINTER   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [33/210]

TABLE_NUMBER_ANGULAR_VELOCITY TABLE_NUMBER_MOMENT I33 Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( DEM_APPLICATION  ,
double  ,
BEAM_INERTIA_ROT_UNIT_LENGHT_X   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [34/210]

TABLE_NUMBER_ANGULAR_VELOCITY TABLE_NUMBER_MOMENT I33 BEAM_INERTIA_ROT_UNIT_LENGHT_Y KRATOS_DEFINE_APPLICATION_VARIABLE (DEM_APPLICATION, double, BEAM_INERTIA_ROT_UNIT_LENGHT_Z) typedef std Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( DEM_APPLICATION  ,
double  ,
FRICTION   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [35/210]

TABLE_NUMBER_ANGULAR_VELOCITY TABLE_NUMBER_MOMENT Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( DEM_APPLICATION  ,
double  ,
I22   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [36/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
bool  ,
DEM_GENERATED   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [37/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
bool  ,
DEMFEM_CONTACT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [38/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
bool  ,
GENERATE_DEM   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [39/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
bool  ,
INACTIVE_NODE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [40/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
bool  ,
IS_DEM   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [41/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
bool  ,
IS_SKIN   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [42/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
bool  ,
IS_TAKEN   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [43/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
bool  ,
NODAL_FORCE_APPLIED   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [44/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
bool  ,
PRESSURE_EXPANDED   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [45/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
bool  ,
RECOMPUTE_NEIGHBOURS   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [46/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
bool  ,
SMOOTHING   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [47/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
ACUMULATED_PLASTIC_STRAIN   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [48/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
DEM_RADIUS   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [49/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
DENSITY_FIBER   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [50/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
EQUIVALENT_NODAL_STRESS   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [51/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
EQUIVALENT_STRESS_VM   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [52/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
FIBER_VOLUMETRIC_PART   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [53/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
FRACTURE_ENERGY_FIBER   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [54/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
INITIAL_THRESHOLD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [55/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
IS_DAMAGED   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [56/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
MAX_PLASTIC_STRAIN   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [57/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
NODAL_FORCE_X   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [58/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
NODAL_FORCE_Y   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [59/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
NODAL_FORCE_Z   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [60/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
PLASTIC_UNIAXIAL_STRESS   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [61/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
POISSON_RATIO_FIBER   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [62/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
STRESS_THRESHOLD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [63/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
YIELD_STRESS_C   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [64/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
YIELD_STRESS_C_FIBER   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [65/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
YIELD_STRESS_T   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [66/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
YIELD_STRESS_T_FIBER   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [67/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
double  ,
YOUNG_MODULUS_FIBER   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [68/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
int  ,
HARDENING_LAW   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [69/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
int  ,
INTEGRATION_COEFFICIENT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [70/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
int  ,
INTERNAL_PRESSURE_ITERATION   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [71/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
int  ,
IS_DYNAMIC   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [72/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
int  ,
NUMBER_OF_ACTIVE_ELEMENTS   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [73/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
int  ,
PFEM_PRESSURE_ITERATION   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [74/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
int  ,
PRESSURE_ID   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [75/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
int  ,
RECONSTRUCT_PRESSURE_LOAD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [76/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
int  ,
TANGENT_CONSTITUTIVE_TENSOR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [77/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
Matrix  ,
FIBER_STRESS_TENSOR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [78/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
Matrix  ,
MATRIX_STRESS_TENSOR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [79/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
Matrix  ,
MATRIX_STRESS_TENSOR_INTEGRATED   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [80/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
Matrix  ,
STRAIN_TENSOR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [81/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
Matrix  ,
STRESS_TENSOR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [82/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
Matrix  ,
STRESS_TENSOR_INTEGRATED   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [83/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
std::string  ,
MAPPING_PROCEDURE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [84/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
std::string  ,
YIELD_SURFACE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [85/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
Vector  ,
DISPLACEMENT_INCREMENT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [86/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
Vector  ,
FIBER_STRESS_VECTOR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [87/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
Vector  ,
MATRIX_STRESS_VECTOR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [88/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
Vector  ,
NODAL_STRESS_VECTOR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [89/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
Vector  ,
SMOOTHED_STRESS_VECTOR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [90/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
Vector  ,
STRAIN_VECTOR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [91/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
Vector  ,
STRESS_VECTOR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [92/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FEM_TO_DEM_APPLICATION  ,
Vector  ,
STRESS_VECTOR_INTEGRATED   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [93/210]

TWSS Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FLUID_DYNAMICS_BIOMEDICAL_APPLICATION  ,
double  ,
ECAP   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [94/210]

TWSS RRT Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FLUID_DYNAMICS_BIOMEDICAL_APPLICATION  ,
double  ,
OSI   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [95/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FLUID_DYNAMICS_BIOMEDICAL_APPLICATION  ,
double  ,
TAWSS   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [96/210]

TWSS RRT WSS Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( FLUID_DYNAMICS_BIOMEDICAL_APPLICATION  ,
double  ,
WALL_DISTANCE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [97/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( GEO_MECHANICS_APPLICATION  ,
std::string  ,
UDSM_NAME   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [98/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( MESHING_APPLICATION  ,
double  ,
ANISOTROPIC_RATIO   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [99/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( MESHING_APPLICATION  ,
double  ,
AVERAGE_NODAL_ERROR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [100/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( MESHING_APPLICATION  ,
double  ,
METRIC_SCALAR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [101/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( MESHING_APPLICATION  ,
int  ,
NUMBER_OF_DIVISIONS   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [102/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( MESHING_APPLICATION  ,
Vector  ,
AUXILIAR_HESSIAN   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [103/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( MESHING_APPLICATION  ,
Vector3  ,
AUXILIAR_GRADIENT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [104/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
bool  ,
COMPUTE_CONTROL_DENSITIES   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [105/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
bool  ,
COMPUTE_CONTROL_POINTS_SHAPE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [106/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
bool  ,
COMPUTE_HELMHOLTZ_INVERSE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [107/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
bool  ,
HELMHOLTZ_INTEGRATED_FIELD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [108/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
CD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [109/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
CROSS_AREA   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [110/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
CROSS_AREA_SENSITIVITY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [111/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
CT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [112/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_CD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [113/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_CT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [114/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_INTERFACE_D_CD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [115/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_INTERFACE_D_FD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [116/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_MASS_D_CD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [117/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_MASS_D_CT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [118/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_MASS_D_FD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [119/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_MASS_D_FT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [120/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_MASS_D_PD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [121/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_MAX_STRESS_D_CD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [122/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_MAX_STRESS_D_CT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [123/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_MAX_STRESS_D_PD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [124/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_MAX_STRESS_D_PT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [125/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_PARTITION_MASS_D_CD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [126/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_PARTITION_MASS_D_FD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [127/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_PD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [128/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_PD_D_FD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [129/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_PE_D_FD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [130/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_PPT_D_FT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [131/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_PT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [132/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_PT_D_FT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [133/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_STRAIN_ENERGY_1_D_CD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [134/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_STRAIN_ENERGY_1_D_CT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [135/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_STRAIN_ENERGY_1_D_FD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [136/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_STRAIN_ENERGY_1_D_FT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [137/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_STRAIN_ENERGY_2_D_CD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [138/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_STRAIN_ENERGY_2_D_CT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [139/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_STRAIN_ENERGY_2_D_FD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [140/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_STRAIN_ENERGY_2_D_FT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [141/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_STRAIN_ENERGY_3_D_CD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [142/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_STRAIN_ENERGY_3_D_CT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [143/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_STRAIN_ENERGY_3_D_FD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [144/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_STRAIN_ENERGY_3_D_FT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [145/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_STRESS_D_CD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [146/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
D_STRESS_D_FD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [147/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
DENSITY_SENSITIVITY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [148/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
ELEMENT_STRAIN_ENERGY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [149/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
FD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [150/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
FT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [151/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
HELMHOLTZ_BULK_POISSON_RATIO_SHAPE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [152/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
HELMHOLTZ_BULK_RADIUS_SHAPE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [153/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
HELMHOLTZ_RADIUS   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [154/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
HELMHOLTZ_RADIUS_DENSITY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [155/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
HELMHOLTZ_RADIUS_THICKNESS   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [156/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
HELMHOLTZ_SCALAR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [157/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
HELMHOLTZ_SCALAR_SOURCE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [158/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
HELMHOLTZ_SOURCE_DENSITY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [159/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
HELMHOLTZ_SOURCE_THICKNESS   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [160/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
HELMHOLTZ_SURF_POISSON_RATIO_SHAPE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [161/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
HELMHOLTZ_SURF_RADIUS_SHAPE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [162/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
HELMHOLTZ_VAR_DENSITY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [163/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
HELMHOLTZ_VAR_THICKNESS   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [164/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
NEAREST_NEIGHBOUR_DIST   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [165/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
PD   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [166/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
PE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [167/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
POISSON_RATIO_SENSITIVITY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [168/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
PPT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [169/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
PT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [170/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
TEMPORARY_SCALAR_VARIABLE_1   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [171/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
TEMPORARY_SCALAR_VARIABLE_2   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [172/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
THICKNESS_SENSITIVITY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [173/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
double  ,
YOUNG_MODULUS_SENSITIVITY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [174/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
int  ,
NEAREST_NEIGHBOUR_COND_ID   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [175/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
Matrix  ,
HELMHOLTZ_MASS_MATRIX   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [176/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( OPTIMIZATION_APPLICATION  ,
std::vector< std::string >  ,
MODEL_PART_STATUS   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [177/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( SHALLOW_WATER_APPLICATION  ,
double  ,
BATHYMETRY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [178/210]

TOPOGRAPHY RAIN CHEZY RELATIVE_DRY_HEIGHT Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( SHALLOW_WATER_APPLICATION  ,
double  ,
DRY_DISCHARGE_PENALTY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [179/210]

TOPOGRAPHY RAIN CHEZY Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( SHALLOW_WATER_APPLICATION  ,
double  ,
DRY_HEIGHT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [180/210]

TOPOGRAPHY Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( SHALLOW_WATER_APPLICATION  ,
double  ,
FROUDE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [181/210]

TOPOGRAPHY RAIN Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( SHALLOW_WATER_APPLICATION  ,
double  ,
MANNING   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [182/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
bool  ,
CONSIDER_IMPLICIT_EAS_SPRISM_ELEMENT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [183/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
bool  ,
CONSIDER_QUADRATIC_SPRISM_ELEMENT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [184/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
bool  ,
CONSIDER_TOTAL_LAGRANGIAN_SPRISM_ELEMENT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [185/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
bool  ,
IS_ADJOINT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [186/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
bool  ,
PURE_EXPLICIT_RHS_COMPUTATION   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [187/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
bool  ,
RESET_EQUATION_IDS   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [188/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
double  ,
ALPHA_EAS   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [189/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
double  ,
ANG_ROT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [190/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
double  ,
AREA_EFFECTIVE_Y_SENSITIVITY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [191/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
double  ,
AREA_EFFECTIVE_Z_SENSITIVITY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [192/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
double  ,
CROSS_AREA_SENSITIVITY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [193/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
double  ,
I22_SENSITIVITY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [194/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
double  ,
I33_SENSITIVITY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [195/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
double  ,
PLASTIC_ALPHA   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [196/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
double  ,
REFERENCE_DEFORMATION_GRADIENT_DETERMINANT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [197/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
double  ,
THICKNESS_SENSITIVITY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [198/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
double  ,
YOUNG_MODULUS_SENSITIVITY   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [199/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
int  ,
INTEGRATION_ORDER   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [200/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
int  ,
TRACED_STRESS_TYPE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [201/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
Matrix  ,
HENCKY_STRAIN_TENSOR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [202/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
Matrix  ,
REFERENCE_DEFORMATION_GRADIENT   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [203/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
Matrix  ,
STRESS_DESIGN_DERIVATIVE_ON_GP   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [204/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
Matrix  ,
STRESS_DESIGN_DERIVATIVE_ON_NODE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [205/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
Matrix  ,
STRESS_DISP_DERIV_ON_GP   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [206/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
Matrix  ,
STRESS_DISP_DERIV_ON_NODE   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [207/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
std::string  ,
DESIGN_VARIABLE_NAME   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [208/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
Vector  ,
HENCKY_STRAIN_VECTOR   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [209/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
Vector  ,
STRESS_ON_GP   
)

◆ KRATOS_DEFINE_APPLICATION_VARIABLE() [210/210]

Kratos::KRATOS_DEFINE_APPLICATION_VARIABLE ( STRUCTURAL_MECHANICS_APPLICATION  ,
Vector  ,
STRESS_ON_NODE   
)

◆ KRATOS_DEFINE_SYMMETRIC_2D_TENSOR_APPLICATION_VARIABLE_WITH_COMPONENTS()

Kratos::KRATOS_DEFINE_SYMMETRIC_2D_TENSOR_APPLICATION_VARIABLE_WITH_COMPONENTS ( MESHING_APPLICATION  ,
METRIC_TENSOR_2D   
)

◆ KRATOS_DEFINE_SYMMETRIC_3D_TENSOR_APPLICATION_VARIABLE_WITH_COMPONENTS() [1/3]

Kratos::KRATOS_DEFINE_SYMMETRIC_3D_TENSOR_APPLICATION_VARIABLE_WITH_COMPONENTS ( CONSTITUTIVE_LAWS_APPLICATION  ,
ISOTROPIC_ANISOTROPIC_YIELD_RATIO   
)

◆ KRATOS_DEFINE_SYMMETRIC_3D_TENSOR_APPLICATION_VARIABLE_WITH_COMPONENTS() [2/3]

Kratos::KRATOS_DEFINE_SYMMETRIC_3D_TENSOR_APPLICATION_VARIABLE_WITH_COMPONENTS ( CONSTITUTIVE_LAWS_APPLICATION  ,
ORTHOTROPIC_ELASTIC_CONSTANTS   
)

◆ KRATOS_DEFINE_SYMMETRIC_3D_TENSOR_APPLICATION_VARIABLE_WITH_COMPONENTS() [3/3]

Kratos::KRATOS_DEFINE_SYMMETRIC_3D_TENSOR_APPLICATION_VARIABLE_WITH_COMPONENTS ( MESHING_APPLICATION  ,
METRIC_TENSOR_3D   
)

◆ KRATOS_DEFINE_VARIABLE() [1/4]

Kratos::KRATOS_DEFINE_VARIABLE ( double  ,
MESH_POISSON_RATIO   
)

◆ KRATOS_DEFINE_VARIABLE() [2/4]

Kratos::KRATOS_DEFINE_VARIABLE ( int  ,
LAPLACIAN_DIRECTION   
)

◆ KRATOS_DEFINE_VARIABLE() [3/4]

Kratos::KRATOS_DEFINE_VARIABLE ( Matrix  ,
BIOT_STRAIN_TENSOR   
)

◆ KRATOS_DEFINE_VARIABLE() [4/4]

Kratos::KRATOS_DEFINE_VARIABLE ( Vector  ,
BIOT_STRAIN_VECTOR   
)

◆ KRATOS_DEPRECATED_MESSAGE()

namespace Kratos::KRATOS_DEPRECATED_MESSAGE ( "Please use std::filesystem directly"  )

◆ make_intrusive()

template<typename C , typename... Args>
intrusive_ptr<C> Kratos::make_intrusive ( Args &&...  args)

◆ make_shared()

template<typename C , typename... Args>
shared_ptr<C> Kratos::make_shared ( Args &&...  args)

◆ make_unique()

template<typename C , typename... Args>
unique_ptr<C> Kratos::make_unique ( Args &&...  args)

◆ MakeIndirectScalar() [1/2]

template<class TVariableType >
IndirectScalar<typename TVariableType::Type> Kratos::MakeIndirectScalar ( Node rNode,
const TVariableType &  rVariable 
)

◆ MakeIndirectScalar() [2/2]

template<class TVariableType >
IndirectScalar<typename TVariableType::Type> Kratos::MakeIndirectScalar ( Node rNode,
const TVariableType &  rVariable,
std::size_t  Step 
)

◆ MakeProxy() [1/2]

template<Globals::DataLocation TLocation, class TEntity >
auto Kratos::MakeProxy ( const TEntity &  rEntity)
inline

Invalid template base to be specialized for valid template parameters.

◆ MakeProxy() [2/2]

template<Globals::DataLocation TLocation, class TEntity >
auto Kratos::MakeProxy ( TEntity &  rEntity)
inline

Invalid template base to be specialized for valid template parameters.

◆ MakeProxy< Globals::DataLocation::ProcessInfo, ModelPart >() [1/2]

template<>
auto Kratos::MakeProxy< Globals::DataLocation::ProcessInfo, ModelPart > ( const ModelPart rModelPart)
inline

Convenience function for constructing a mutable ProcessInfo proxy from a ModelPart.

◆ MakeProxy< Globals::DataLocation::ProcessInfo, ModelPart >() [2/2]

template<>
auto Kratos::MakeProxy< Globals::DataLocation::ProcessInfo, ModelPart > ( ModelPart rModelPart)
inline

Convenience function for constructing an immutable ProcessInfo proxy from a ModelPart.

◆ ModelPartOperationUtilities::CheckEntities< ModelPart::ConditionsContainerType >()

template void Kratos::ModelPartOperationUtilities::CheckEntities< ModelPart::ConditionsContainerType > ( std::vector< IndexType > &  ,
const ModelPart::ConditionsContainerType ,
const std::set< CNodePointersType > &   
)

◆ ModelPartOperationUtilities::CheckEntities< ModelPart::ElementsContainerType >()

template void Kratos::ModelPartOperationUtilities::CheckEntities< ModelPart::ElementsContainerType > ( std::vector< IndexType > &  ,
const ModelPart::ElementsContainerType ,
const std::set< CNodePointersType > &   
)

◆ ModelPartOperationUtilities::FillNodePointersForEntities< ModelPart::ConditionsContainerType >()

template void Kratos::ModelPartOperationUtilities::FillNodePointersForEntities< ModelPart::ConditionsContainerType > ( std::set< CNodePointersType > &  ,
const ModelPart::ConditionsContainerType  
)

◆ ModelPartOperationUtilities::FillNodePointersForEntities< ModelPart::ElementsContainerType >()

template void Kratos::ModelPartOperationUtilities::FillNodePointersForEntities< ModelPart::ElementsContainerType > ( std::set< CNodePointersType > &  ,
const ModelPart::ElementsContainerType  
)

◆ ModelPartOperationUtilities::FillNodesFromEntities< ModelPart::ConditionType >()

template void Kratos::ModelPartOperationUtilities::FillNodesFromEntities< ModelPart::ConditionType > ( std::vector< ModelPart::NodeType * > &  ,
typename std::vector< ModelPart::ConditionType * >::iterator  ,
typename std::vector< ModelPart::ConditionType * >::iterator   
)

◆ ModelPartOperationUtilities::FillNodesFromEntities< ModelPart::ElementType >()

template void Kratos::ModelPartOperationUtilities::FillNodesFromEntities< ModelPart::ElementType > ( std::vector< ModelPart::NodeType * > &  ,
typename std::vector< ModelPart::ElementType * >::iterator  ,
typename std::vector< ModelPart::ElementType * >::iterator   
)

◆ ModelPartOperationUtilities::FindNeighbourEntities< ModelPart::ConditionsContainerType >()

template void Kratos::ModelPartOperationUtilities::FindNeighbourEntities< ModelPart::ConditionsContainerType > ( std::vector< ModelPart::ConditionType * > &  ,
const Flags ,
ModelPart::ConditionsContainerType  
)

◆ ModelPartOperationUtilities::FindNeighbourEntities< ModelPart::ElementsContainerType >()

template void Kratos::ModelPartOperationUtilities::FindNeighbourEntities< ModelPart::ElementsContainerType > ( std::vector< ModelPart::ElementType * > &  ,
const Flags ,
ModelPart::ElementsContainerType  
)

◆ ModifyViscosityLikeEinstein()

void Kratos::ModifyViscosityLikeEinstein ( double viscosity,
const double  solid_fraction 
)

This class allows the interpolation between non-matching simplicial meshes in 2D and 3D with linear shape functions. it is designed for DEM-CFD coupling problems.

Author
Guillermo Casas Gonzalez gcasa.nosp@m.s@ci.nosp@m.mne.u.nosp@m.pc.e.nosp@m.du

For every node of the destination model part it is checked in which element of the origin model part it is contained and a linear interpolation is performed

The data structure used by default is a bin,

For a more general tool that allows the mapping between 2 and 3D non-matching meshes, please see /kratos/applications/MeshingApplication/custom_utilities/projection.h

◆ ModifyViscosityLikeLiu()

void Kratos::ModifyViscosityLikeLiu ( double viscosity,
const double  solid_fraction 
)

◆ msGeometryDimension() [1/34]

template<class TPointType >
const GeometryData Hexahedra3D20<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [2/34]

template<class TPointType >
const GeometryData Hexahedra3D27<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [3/34]

template<class TPointType >
const GeometryData Hexahedra3D8<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [4/34]

template<class TPointType >
const GeometryData HexahedraInterface3D8<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [5/34]

template<class TPointType >
const GeometryData Line2D2<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [6/34]

template<class TPointType >
const GeometryData Line2D3<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [7/34]

template<class TPointType >
const GeometryData Line2D4<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [8/34]

template<class TPointType >
const GeometryData Line2D5<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [9/34]

template<class TPointType >
const GeometryData Line3D2<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [10/34]

template<class TPointType >
const GeometryData Line3D3<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [11/34]

template<class TPointType >
const GeometryData Line3DN<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [12/34]

template<class TPointType >
const GeometryData LineGaussLobatto3D2<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [13/34]

template<class TPointType >
const GeometryData Point2D<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [14/34]

template<class TPointType >
const GeometryData Point3D<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [15/34]

template<class TPointType >
const GeometryData Prism3D15<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [16/34]

template<class TPointType >
const GeometryData Prism3D6<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [17/34]

template<class TPointType >
const GeometryData PrismInterface3D6<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [18/34]

template<class TPointType >
const GeometryData Pyramid3D13<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [19/34]

template<class TPointType >
const GeometryData Pyramid3D5<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [20/34]

template<class TPointType >
const GeometryData Quadrilateral2D4<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [21/34]

template<class TPointType >
const GeometryData Quadrilateral2D8<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [22/34]

template<class TPointType >
const GeometryData Quadrilateral2D9<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [23/34]

template<class TPointType >
const GeometryData Quadrilateral3D4<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [24/34]

template<class TPointType >
const GeometryData Quadrilateral3D8<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [25/34]

template<class TPointType >
const GeometryData Quadrilateral3D9<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [26/34]

template<class TPointType >
const GeometryData QuadrilateralInterface2D4<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [27/34]

template<class TPointType >
const GeometryData QuadrilateralInterface3D4<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [28/34]

template<class TPointType >
const GeometryData Tetrahedra3D4<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [29/34]

template<class TPointType >
const GeometryData Triangle2D10<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [30/34]

template<class TPointType >
const GeometryData Triangle2D15<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [31/34]

template<class TPointType >
const GeometryData Triangle2D3<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [32/34]

template<class TPointType >
const GeometryData Triangle2D6<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [33/34]

template<class TPointType >
const GeometryData Triangle3D3<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ msGeometryDimension() [34/34]

template<class TPointType >
const GeometryData Triangle3D6<TPointType>::msGeometryData & Kratos::msGeometryDimension ( )

◆ noalias()

template<typename T >
T& Kratos::noalias ( T &  TheMatrix)

◆ norm_1()

template<typename TExpressionType , std::size_t TCategory>
TExpressionType::data_type Kratos::norm_1 ( AMatrix::MatrixExpression< TExpressionType, TCategory > const &  TheExpression)

◆ norm_2()

template<typename TExpressionType , std::size_t TCategory>
TExpressionType::data_type Kratos::norm_2 ( AMatrix::MatrixExpression< TExpressionType, TCategory > const &  TheExpression)

◆ norm_frobenius()

template<typename TExpressionType , std::size_t TCategory>
TExpressionType::data_type Kratos::norm_frobenius ( AMatrix::MatrixExpression< TExpressionType, TCategory > const &  TheExpression)

◆ NormalCalculationUtils::CalculateNormals< ModelPart::ConditionsContainerType, false >()

template<>
void Kratos::NormalCalculationUtils::CalculateNormals< ModelPart::ConditionsContainerType, false > ( ModelPart rModelPart,
const bool  EnforceGenericGeometryAlgorithm,
const bool  ConsiderUnitNormal,
const Variable< array_1d< double, 3 >> &  rNormalVariable 
)

◆ NormalCalculationUtils::CalculateNormals< ModelPart::ConditionsContainerType, true >()

template<>
void Kratos::NormalCalculationUtils::CalculateNormals< ModelPart::ConditionsContainerType, true > ( ModelPart rModelPart,
const bool  EnforceGenericGeometryAlgorithm,
const bool  ConsiderUnitNormal,
const Variable< array_1d< double, 3 >> &  rNormalVariable 
)

◆ NormalCalculationUtils::CalculateNormals< ModelPart::ElementsContainerType, false >()

template<>
void Kratos::NormalCalculationUtils::CalculateNormals< ModelPart::ElementsContainerType, false > ( ModelPart rModelPart,
const bool  EnforceGenericGeometryAlgorithm,
const bool  ConsiderUnitNormal,
const Variable< array_1d< double, 3 >> &  rNormalVariable 
)

◆ NormalCalculationUtils::CalculateNormals< ModelPart::ElementsContainerType, true >()

template<>
void Kratos::NormalCalculationUtils::CalculateNormals< ModelPart::ElementsContainerType, true > ( ModelPart rModelPart,
const bool  EnforceGenericGeometryAlgorithm,
const bool  ConsiderUnitNormal,
const Variable< array_1d< double, 3 >> &  rNormalVariable 
)

◆ NormalCalculationUtils::CalculateNormalsInContainer< ModelPart::ConditionsContainerType >()

◆ NormalCalculationUtils::CalculateNormalsInContainer< ModelPart::ElementsContainerType >()

◆ NormalCalculationUtils::CalculateNormalsUsingGenericAlgorithm< ModelPart::ConditionsContainerType, false >()

template void Kratos::NormalCalculationUtils::CalculateNormalsUsingGenericAlgorithm< ModelPart::ConditionsContainerType, false > ( ModelPart ,
const bool  ,
const NormalVariableType &   
)

◆ NormalCalculationUtils::CalculateNormalsUsingGenericAlgorithm< ModelPart::ConditionsContainerType, true >()

template void Kratos::NormalCalculationUtils::CalculateNormalsUsingGenericAlgorithm< ModelPart::ConditionsContainerType, true > ( ModelPart ,
const bool  ,
const NormalVariableType &   
)

◆ NormalCalculationUtils::CalculateNormalsUsingGenericAlgorithm< ModelPart::ElementsContainerType, false >()

template void Kratos::NormalCalculationUtils::CalculateNormalsUsingGenericAlgorithm< ModelPart::ElementsContainerType, false > ( ModelPart ,
const bool  ,
const NormalVariableType &   
)

◆ NormalCalculationUtils::CalculateNormalsUsingGenericAlgorithm< ModelPart::ElementsContainerType, true >()

template void Kratos::NormalCalculationUtils::CalculateNormalsUsingGenericAlgorithm< ModelPart::ElementsContainerType, true > ( ModelPart ,
const bool  ,
const NormalVariableType &   
)

◆ NormalCalculationUtils::CalculateUnitNormals< ModelPart::ConditionsContainerType, false >()

template void Kratos::NormalCalculationUtils::CalculateUnitNormals< ModelPart::ConditionsContainerType, false > ( ModelPart ,
const bool  ,
const NormalVariableType &   
)

◆ NormalCalculationUtils::CalculateUnitNormals< ModelPart::ConditionsContainerType, true >()

template void Kratos::NormalCalculationUtils::CalculateUnitNormals< ModelPart::ConditionsContainerType, true > ( ModelPart ,
const bool  ,
const NormalVariableType &   
)

◆ NormalCalculationUtils::CalculateUnitNormals< ModelPart::ElementsContainerType, false >()

template void Kratos::NormalCalculationUtils::CalculateUnitNormals< ModelPart::ElementsContainerType, false > ( ModelPart ,
const bool  ,
const NormalVariableType &   
)

◆ NormalCalculationUtils::CalculateUnitNormals< ModelPart::ElementsContainerType, true >()

template void Kratos::NormalCalculationUtils::CalculateUnitNormals< ModelPart::ElementsContainerType, true > ( ModelPart ,
const bool  ,
const NormalVariableType &   
)

◆ NormalCalculationUtils::InitializeNormals< ModelPart::ConditionsContainerType, false >()

template void Kratos::NormalCalculationUtils::InitializeNormals< ModelPart::ConditionsContainerType, false > ( ModelPart ,
const NormalVariableType &   
)

◆ NormalCalculationUtils::InitializeNormals< ModelPart::ConditionsContainerType, true >()

template void Kratos::NormalCalculationUtils::InitializeNormals< ModelPart::ConditionsContainerType, true > ( ModelPart ,
const NormalVariableType &   
)

◆ NormalCalculationUtils::InitializeNormals< ModelPart::ElementsContainerType, false >()

template void Kratos::NormalCalculationUtils::InitializeNormals< ModelPart::ElementsContainerType, false > ( ModelPart ,
const NormalVariableType &   
)

◆ NormalCalculationUtils::InitializeNormals< ModelPart::ElementsContainerType, true >()

template void Kratos::NormalCalculationUtils::InitializeNormals< ModelPart::ElementsContainerType, true > ( ModelPart ,
const NormalVariableType &   
)

◆ operator()

Kratos::PeriodicInterfaceProcess Process Kratos::operator ( std::istream &  rIStream,
PeriodicInterfaceProcess rThis 
)

input stream function

◆ operator!=()

bool Kratos::operator!= ( const Flags Left,
const Flags Right 
)

◆ operator&()

Flags Kratos::operator& ( const Flags Left,
const Flags Right 
)

◆ operator*() [1/10]

◆ operator*() [2/10]

CollectiveExpression Kratos::operator* ( const CollectiveExpression rLeft,
const double  Right 
)

◆ operator*() [3/10]

template<class TContainerType , MeshType TMeshType>
ContainerExpression<TContainerType, TMeshType> Kratos::operator* ( const ContainerExpression< TContainerType, TMeshType > &  rLeft,
const ContainerExpression< TContainerType, TMeshType > &  rRight 
)

◆ operator*() [4/10]

template<class TContainerType , MeshType TMeshType>
ContainerExpression<TContainerType, TMeshType> Kratos::operator* ( const ContainerExpression< TContainerType, TMeshType > &  rLeft,
const double  Right 
)

◆ operator*() [5/10]

CollectiveExpression Kratos::operator* ( const double  Left,
const CollectiveExpression rRight 
)

◆ operator*() [6/10]

template<class TContainerType , MeshType TMeshType>
ContainerExpression<TContainerType, TMeshType> Kratos::operator* ( const double  Left,
const ContainerExpression< TContainerType, TMeshType > &  rRight 
)

◆ operator*() [7/10]

Expression::Pointer Kratos::operator* ( const double  Left,
const Expression::ConstPointer rpRight 
)

◆ operator*() [8/10]

Expression::Pointer Kratos::operator* ( const Expression::ConstPointer rpLeft,
const double  Right 
)

◆ operator*() [9/10]

◆ operator*() [10/10]

template<class T >
Quaternion<T> Kratos::operator* ( const Quaternion< T > &  a,
const Quaternion< T > &  b 
)
inline

Performs a Quaternion-Quaternion product and returns the concatenation of the two input quaternions (i.e. the compound rotation)

Parameters
athe first quaternion
bthe second quaternion
Returns
the compound quaternion

◆ operator+() [1/9]

◆ operator+() [2/9]

CollectiveExpression Kratos::operator+ ( const CollectiveExpression rLeft,
const double  Right 
)

◆ operator+() [3/9]

template<class TContainerType , MeshType TMeshType>
ContainerExpression<TContainerType, TMeshType> Kratos::operator+ ( const ContainerExpression< TContainerType, TMeshType > &  rLeft,
const ContainerExpression< TContainerType, TMeshType > &  rRight 
)

◆ operator+() [4/9]

template<class TContainerType , MeshType TMeshType>
ContainerExpression<TContainerType, TMeshType> Kratos::operator+ ( const ContainerExpression< TContainerType, TMeshType > &  rLeft,
const double  Right 
)

◆ operator+() [5/9]

CollectiveExpression Kratos::operator+ ( const double  Left,
const CollectiveExpression rRight 
)

◆ operator+() [6/9]

template<class TContainerType , MeshType TMeshType>
ContainerExpression<TContainerType, TMeshType> Kratos::operator+ ( const double  Left,
const ContainerExpression< TContainerType, TMeshType > &  rRight 
)

◆ operator+() [7/9]

Expression::Pointer Kratos::operator+ ( const double  Left,
const Expression::ConstPointer rpRight 
)

◆ operator+() [8/9]

Expression::Pointer Kratos::operator+ ( const Expression::ConstPointer rpLeft,
const double  Right 
)

◆ operator+() [9/9]

◆ operator-() [1/9]

◆ operator-() [2/9]

CollectiveExpression Kratos::operator- ( const CollectiveExpression rLeft,
const double  Right 
)

◆ operator-() [3/9]

template<class TContainerType , MeshType TMeshType>
ContainerExpression<TContainerType, TMeshType> Kratos::operator- ( const ContainerExpression< TContainerType, TMeshType > &  rLeft,
const ContainerExpression< TContainerType, TMeshType > &  rRight 
)

◆ operator-() [4/9]

template<class TContainerType , MeshType TMeshType>
ContainerExpression<TContainerType, TMeshType> Kratos::operator- ( const ContainerExpression< TContainerType, TMeshType > &  rLeft,
const double  Right 
)

◆ operator-() [5/9]

CollectiveExpression Kratos::operator- ( const double  Left,
const CollectiveExpression rRight 
)

◆ operator-() [6/9]

template<class TContainerType , MeshType TMeshType>
ContainerExpression<TContainerType, TMeshType> Kratos::operator- ( const double  Left,
const ContainerExpression< TContainerType, TMeshType > &  rRight 
)

◆ operator-() [7/9]

Expression::Pointer Kratos::operator- ( const double  Left,
const Expression::ConstPointer rpRight 
)

◆ operator-() [8/9]

Expression::Pointer Kratos::operator- ( const Expression::ConstPointer rpLeft,
const double  Right 
)

◆ operator-() [9/9]

◆ operator/() [1/9]

◆ operator/() [2/9]

CollectiveExpression Kratos::operator/ ( const CollectiveExpression rLeft,
const double  Right 
)

◆ operator/() [3/9]

template<class TContainerType , MeshType TMeshType>
ContainerExpression<TContainerType, TMeshType> Kratos::operator/ ( const ContainerExpression< TContainerType, TMeshType > &  rLeft,
const ContainerExpression< TContainerType, TMeshType > &  rRight 
)

◆ operator/() [4/9]

template<class TContainerType , MeshType TMeshType>
ContainerExpression<TContainerType, TMeshType> Kratos::operator/ ( const ContainerExpression< TContainerType, TMeshType > &  rLeft,
const double  Right 
)

◆ operator/() [5/9]

CollectiveExpression Kratos::operator/ ( const double  Left,
const CollectiveExpression rRight 
)

◆ operator/() [6/9]

template<class TContainerType , MeshType TMeshType>
ContainerExpression<TContainerType, TMeshType> Kratos::operator/ ( const double  Left,
const ContainerExpression< TContainerType, TMeshType > &  rRight 
)

◆ operator/() [7/9]

Expression::Pointer Kratos::operator/ ( const double  Left,
const Expression::ConstPointer rpRight 
)

◆ operator/() [8/9]

Expression::Pointer Kratos::operator/ ( const Expression::ConstPointer rpLeft,
const double  Right 
)

◆ operator/() [9/9]

◆ operator<()

template<class TDataType >
bool Kratos::operator< ( Dof< TDataType > const &  First,
Dof< TDataType > const &  Second 
)
inline

Less than operator.

◆ operator<<() [1/156]

template<class T >
std::ostream& Kratos::operator<< ( std::ostream &  os,
const IndirectScalar< T > &  s 
)

◆ operator<<() [2/156]

template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::ostream& Kratos::operator<< ( std::ostream &  OStream,
const TFQMRSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &  rThis 
)
inline

output stream function

◆ operator<<() [3/156]

template<std::size_t TDimension, class TPointType , class TContainerType , class TPointerType , class TIteratorType , class TDistanceIteratorType , class TDistanceFunction >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
Bins< TDimension, TPointType, TContainerType, TPointerType, TIteratorType, TDistanceIteratorType, TDistanceFunction > &  rThis 
)

◆ operator<<() [4/156]

std::ostream & Kratos::operator<< ( std::ostream &  rOStream,
const @{KRATOS_NAME_CAMEL}&  rThis 
)
inline

output stream function

Constructor.

◆ operator<<() [5/156]

template<class TPrimalCondition >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const AdjointPotentialWallCondition< TPrimalCondition > &  rThis 
)
inline

output stream function

◆ operator<<() [6/156]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const Amesos2Solver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

output stream function

◆ operator<<() [7/156]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const AmesosSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

output stream function

◆ operator<<() [8/156]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const AMGCL_NS_Solver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

output stream function

◆ operator<<() [9/156]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const AmgclMPISchurComplementSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

◆ operator<<() [10/156]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const AmgclMPISolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

output stream function

◆ operator<<() [11/156]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const AMGCLSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

output stream function

◆ operator<<() [12/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const AnalyticRigidBodyElement rThis 
)
inline

output stream function

◆ operator<<() [13/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const AnalyticSphericParticle rThis 
)
inline

output stream function

◆ operator<<() [14/156]

std::ostream & Kratos::operator<< ( std::ostream &  rOStream,
const ApplyComponentTableProcess rThis 
)
inline

output stream function

◆ operator<<() [15/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ApplyComponentTableProcessDam rThis 
)
inline

output stream function

◆ operator<<() [16/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ApplyConstantHydrostaticPressureProcess rThis 
)
inline

output stream function

◆ operator<<() [17/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ApplyConstantInterpolateLinePressureProcess rThis 
)
inline

output stream function

◆ operator<<() [18/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ApplyConstantPhreaticMultiLinePressureProcess rThis 
)
inline

output stream function

◆ operator<<() [19/156]

std::ostream & Kratos::operator<< ( std::ostream &  rOStream,
const ApplyDoubleTableProcess rThis 
)
inline

output stream function

◆ operator<<() [20/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ApplyHydrostaticPressureTableProcess rThis 
)
inline

output stream function

◆ operator<<() [21/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ApplyPhreaticMultiLinePressureTableProcess rThis 
)
inline

output stream function

◆ operator<<() [22/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ApplyRigidRotationProcess rThis 
)
inline

output stream function

◆ operator<<() [23/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ApplyWriteScalarProcess rThis 
)
inline

output stream function

◆ operator<<() [24/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const AutomaticDTProcess rThis 
)
inline

output stream function

◆ operator<<() [25/156]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const AztecSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

output stream function

◆ operator<<() [26/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const BeamParticle rThis 
)
inline

output stream function

◆ operator<<() [27/156]

template<std::size_t TDim, typename TBaseTypeOfSwimmingParticle >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const BinBasedDEMFluidCoupledMapping< TDim, TBaseTypeOfSwimmingParticle > &  rThis 
)
inline

output stream function

◆ operator<<() [28/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const BuiltinTimer rThis 
)
inline

output stream function

◆ operator<<() [29/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const Cluster3D rThis 
)
inline

output stream function

◆ operator<<() [30/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ClusterInformation rThis 
)
inline

◆ operator<<() [31/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ContactInfoSphericParticle rThis 
)
inline

output stream function

◆ operator<<() [32/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ContactMasterSlaveConstraint rThis 
)
inline

output stream function

◆ operator<<() [33/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ControlModule2DProcess rThis 
)
inline

output stream function

◆ operator<<() [34/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ControlModuleProcess rThis 
)
inline

output stream function

◆ operator<<() [35/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ConvectionModel rThis 
)
inline

◆ operator<<() [36/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const CylinderContinuumParticle rThis 
)
inline

output stream function

◆ operator<<() [37/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const CylinderParticle rThis 
)
inline

output stream function

◆ operator<<() [38/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamAddedMassConditionProcess rThis 
)
inline

output stream function

◆ operator<<() [39/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamAzenhaHeatFluxProcess rThis 
)
inline

output stream function

◆ operator<<() [40/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamBofangConditionTemperatureProcess rThis 
)
inline

output stream function

◆ operator<<() [41/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamChemoMechanicalAgingYoungProcess rThis 
)
inline

output stream function

◆ operator<<() [42/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamFixTemperatureConditionProcess rThis 
)
inline

output stream function

◆ operator<<() [43/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamGroutingReferenceTemperatureProcess rThis 
)
inline

output stream function

◆ operator<<() [44/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamHydroConditionLoadProcess rThis 
)
inline

output stream function

◆ operator<<() [45/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamInputTableNodalYoungModulusProcess rThis 
)
inline

output stream function

◆ operator<<() [46/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamNodalReferenceTemperatureProcess rThis 
)
inline

output stream function

◆ operator<<() [47/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamNodalYoungModulusProcess rThis 
)
inline

output stream function

◆ operator<<() [48/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamNoorzaiHeatFluxProcess rThis 
)
inline

output stream function

◆ operator<<() [49/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamRandomFieldsVariableProcess rThis 
)
inline

output stream function

◆ operator<<() [50/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamReservoirConstantTemperatureProcess rThis 
)
inline

output stream function

◆ operator<<() [51/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamReservoirMonitoringTemperatureProcess rThis 
)
inline

output stream function

◆ operator<<() [52/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamTemperaturebyDeviceProcess rThis 
)
inline

output stream function

◆ operator<<() [53/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamTSolAirHeatFluxProcess rThis 
)
inline

output stream function

◆ operator<<() [54/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamUpliftCircularConditionLoadProcess rThis 
)
inline

output stream function

◆ operator<<() [55/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamUpliftConditionLoadProcess rThis 
)
inline

output stream function

◆ operator<<() [56/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DamWestergaardConditionLoadProcess rThis 
)
inline

output stream function

◆ operator<<() [57/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DEMIntegrationScheme rThis 
)
inline

output stream function

◆ operator<<() [58/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DirectConductionBOBComplete rThis 
)
inline

◆ operator<<() [59/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DirectConductionBOBModified rThis 
)
inline

◆ operator<<() [60/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DirectConductionBOBSimple rThis 
)
inline

◆ operator<<() [61/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DirectConductionCollision rThis 
)
inline

◆ operator<<() [62/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DirectConductionModel rThis 
)
inline

◆ operator<<() [63/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DirectConductionPipe rThis 
)
inline

◆ operator<<() [64/156]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DirectSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

output stream function

◆ operator<<() [65/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DiscreteElement rThis 
)
inline

output stream function

◆ operator<<() [66/156]

template<class TSolverType , class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const EigenDenseDirectSolver< TSolverType, TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

output stream function

◆ operator<<() [67/156]

template<class TSolverType , class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const EigenDirectSolver< TSolverType, TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

output stream function

◆ operator<<() [68/156]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const EigensystemSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

output stream function

◆ operator<<() [69/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ElementDeactivationProcess rThis 
)
inline

output stream function

◆ operator<<() [70/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const Expression rThis 
)
inline

output stream functions

◆ operator<<() [71/156]

template<bool TSymmetric, typename TScalarIn , typename TScalarOut >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const FEASTEigensystemSolver< TSymmetric, TScalarIn, TScalarOut > &  rThis 
)
inline

output stream function

◆ operator<<() [72/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ForwardEulerScheme rThis 
)
inline

◆ operator<<() [73/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const GenerationDissipation rThis 
)
inline

◆ operator<<() [74/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const GenerationModel rThis 
)
inline

◆ operator<<() [75/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const GluedToWallScheme rThis 
)
inline

◆ operator<<() [76/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const HeatExchangeMechanism rThis 
)
inline

◆ operator<<() [77/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const HeatGenerationMechanism rThis 
)
inline

◆ operator<<() [78/156]

template<class TPointType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const Hexahedra3D20< TPointType > &  rThis 
)
inline

output stream function

◆ operator<<() [79/156]

template<class TPointType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const Hexahedra3D27< TPointType > &  rThis 
)
inline

output stream function

◆ operator<<() [80/156]

template<class TPointType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const Hexahedra3D8< TPointType > &  rThis 
)
inline

output stream function

◆ operator<<() [81/156]

template<class TPointType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const HexahedraInterface3D8< TPointType > &  rThis 
)
inline

output stream function

◆ operator<<() [82/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const HybridBashforthScheme rThis 
)
inline

◆ operator<<() [83/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const IceContinuumParticle rThis 
)
inline

output stream function

◆ operator<<() [84/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ImposeZStrainProcess rThis 
)
inline

output stream function

◆ operator<<() [85/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const IndexedPoint rThis 
)
inline

output stream function

◆ operator<<() [86/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const IndirectConductionModel rThis 
)
inline

◆ operator<<() [87/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const IndirectConductionSurroundLayer rThis 
)
inline

◆ operator<<() [88/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const IndirectConductionVargas rThis 
)
inline

◆ operator<<() [89/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const IndirectConductionVoronoiA rThis 
)
inline

◆ operator<<() [90/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const IndirectConductionVoronoiB rThis 
)
inline

◆ operator<<() [91/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const IntervalUtility rThis 
)
inline

output stream function

◆ operator<<() [92/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const kDOP rThis 
)
inline

output stream function

◆ operator<<() [93/156]

template<class T >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const Kratos::intrusive_ptr< T > &  rData 
)

◆ operator<<() [94/156]

template<class T >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const Kratos::weak_ptr< T > &  rData 
)

◆ operator<<() [95/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const LagrangianRotationProcess rThis 
)
inline

output stream function

◆ operator<<() [96/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const LinearMasterSlaveConstraint rThis 
)
inline

output stream function

◆ operator<<() [97/156]

template<class TSparseSpace , class TDenseSpace >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const Mapper< TSparseSpace, TDenseSpace > &  rThis 
)
inline

output stream function

◆ operator<<() [98/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const MasterSlaveConstraint rThis 
)
inline

output stream function

◆ operator<<() [99/156]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const MultiLevelSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

output stream function

◆ operator<<() [100/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const NanoParticle rThis 
)
inline

output stream function

◆ operator<<() [101/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const NusseltGunn rThis 
)
inline

◆ operator<<() [102/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const NusseltHanzMarshall rThis 
)
inline

◆ operator<<() [103/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const NusseltLiMason rThis 
)
inline

◆ operator<<() [104/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const NusseltWhitaker rThis 
)
inline

◆ operator<<() [105/156]

std::ostream & Kratos::operator<< ( std::ostream &  rOStream,
const PeriodicInterfaceProcess rThis 
)
inline

output stream function

◆ operator<<() [106/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const PfemFluidGidIO<> &  rThis 
)
inline

◆ operator<<() [107/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const PolyhedronSkinSphericParticle rThis 
)
inline

output stream function

◆ operator<<() [108/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const PoromechanicsFaceLoadControlModuleProcess rThis 
)
inline

output stream function

◆ operator<<() [109/156]

template<class TPointType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const Prism3D15< TPointType > &  rThis 
)
inline

output stream function

◆ operator<<() [110/156]

template<class TPointType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const Prism3D6< TPointType > &  rThis 
)
inline

output stream function

◆ operator<<() [111/156]

template<class TPointType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const Quadrilateral2D8< TPointType > &  rThis 
)
inline

output stream function

◆ operator<<() [112/156]

template<class TPointType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const Quadrilateral2D9< TPointType > &  rThis 
)
inline

output stream function

◆ operator<<() [113/156]

template<class TPointType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const Quadrilateral3D8< TPointType > &  rThis 
)
inline

output stream function

◆ operator<<() [114/156]

template<class TPointType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const Quadrilateral3D9< TPointType > &  rThis 
)
inline

output stream function

◆ operator<<() [115/156]

template<class T >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const Quaternion< T > &  rThis 
)
inline

◆ operator<<() [116/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const QuaternionIntegrationScheme rThis 
)
inline

◆ operator<<() [117/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const RadiationContinuumKrause rThis 
)
inline

◆ operator<<() [118/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const RadiationContinuumZhou rThis 
)
inline

◆ operator<<() [119/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const RadiationModel rThis 
)
inline

◆ operator<<() [120/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const RealContactLu rThis 
)
inline

◆ operator<<() [121/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const RealContactModel rThis 
)
inline

◆ operator<<() [122/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const RealContactMorris rThis 
)
inline

◆ operator<<() [123/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const RealContactZhou rThis 
)
inline

◆ operator<<() [124/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const RetentionLaw rThis 
)
inline

output stream function

◆ operator<<() [125/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const RigidBodyElement3D rThis 
)
inline

output stream function

◆ operator<<() [126/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const RungeKuttaScheme rThis 
)
inline

◆ operator<<() [127/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SetAutomatedInitialDamageProcess rThis 
)
inline

output stream function

◆ operator<<() [128/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SetAutomatedInitialVariableProcess rThis 
)
inline

output stream function

◆ operator<<() [129/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SetCartesianLocalAxesProcess rThis 
)
inline

output stream function

◆ operator<<() [130/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SetCylindricalLocalAxesProcess rThis 
)
inline

output stream function

◆ operator<<() [131/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SetDummyPropertyForRigidElementsProcess rThis 
)
inline

output stream function

◆ operator<<() [132/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SetMaterialPropertiesForThermalCouplingProcess rThis 
)
inline

output stream function

◆ operator<<() [133/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SetMeshVelocityForThermalCouplingProcess rThis 
)
inline

output stream function

◆ operator<<() [134/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SetSphericalLocalAxesProcess rThis 
)
inline

output stream function

◆ operator<<() [135/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ShellCrossSection rThis 
)
inline

◆ operator<<() [136/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ShipElement3D rThis 
)
inline

output stream function

◆ operator<<() [137/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SingleSphereCluster3D rThis 
)
inline

output stream function

◆ operator<<() [138/156]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SkylineLUFactorizationSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

output stream function

◆ operator<<() [139/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SlipConstraint rThis 
)
inline

output stream function

◆ operator<<() [140/156]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SpectraSymGEigsShiftSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

output stream function

◆ operator<<() [141/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SphericContinuumParticle rThis 
)
inline

output stream function

◆ operator<<() [142/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SphericParticle rThis 
)
inline

output stream function

◆ operator<<() [143/156]

template<class T >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const std::vector< T > &  rVec 
)

◆ operator<<() [144/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SymplecticEulerOldVelocityScheme rThis 
)
inline

◆ operator<<() [145/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SymplecticEulerScheme rThis 
)
inline

◆ operator<<() [146/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const TaylorScheme rThis 
)
inline

◆ operator<<() [147/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const TerminalVelocityScheme rThis 
)
inline

◆ operator<<() [148/156]

template<class TPointType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const Tetrahedra3D4< TPointType > &  rThis 
)
inline

output stream function

◆ operator<<() [149/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ThermalDEMIntegrationScheme rThis 
)
inline

◆ operator<<() [150/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ThermalForwardEulerScheme rThis 
)
inline

◆ operator<<() [151/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const ThermalSphericParticle rThis 
)
inline

◆ operator<<() [152/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const UpdateThermalModelPartProcess rThis 
)
inline

output stream function

◆ operator<<() [153/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const VelocityVerletScheme rThis 
)
inline

◆ operator<<() [154/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
ShellCrossSection rThis 
)
inline

◆ operator<<() [155/156]

std::ostream& Kratos::operator<< ( std::ostream &  rOut,
const PropertiesProxy rTheProxies 
)
inline

◆ operator<<() [156/156]

template<std::size_t Dimension>
std::ostream& Kratos::operator<< ( std::ostream &  rOut,
RadiusPoint< Dimension > &  rPoint 
)

◆ operator<=()

template<class TDataType >
bool Kratos::operator<= ( Dof< TDataType > const &  First,
Dof< TDataType > const &  Second 
)
inline

Less equal operator.

◆ operator==() [1/2]

bool Kratos::operator== ( const Flags Left,
const Flags Right 
)

◆ operator==() [2/2]

template<class TDataType >
bool Kratos::operator== ( Dof< TDataType > const &  First,
Dof< TDataType > const &  Second 
)
inline

Equal operator.

◆ operator>()

template<class TDataType >
bool Kratos::operator> ( Dof< TDataType > const &  First,
Dof< TDataType > const &  Second 
)
inline

Greater than operator.

◆ operator>=()

template<class TDataType >
bool Kratos::operator>= ( Dof< TDataType > const &  First,
Dof< TDataType > const &  Second 
)
inline

Greater equal operator.

◆ operator>>() [1/135]

template<class TSparseSpaceType , class TDenseSpaceType , class TPreconditionerType , class TReordererType >
std::istream& Kratos::operator>> ( std::istream &  IStream,
TFQMRSolver< TSparseSpaceType, TDenseSpaceType, TPreconditionerType, TReordererType > &  rThis 
)
inline

input stream function

◆ operator>>() [2/135]

template<std::size_t Dimension>
std::istream& Kratos::operator>> ( std::istream &  rIn,
RadiusPoint< Dimension > &  rPoint 
)

◆ operator>>() [3/135]

template<class TPrimalCondition >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
AdjointPotentialWallCondition< TPrimalCondition > &  rThis 
)
inline

input stream function

◆ operator>>() [4/135]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
AMGCL_NS_Solver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

input stream function

◆ operator>>() [5/135]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
AMGCLSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

input stream function

◆ operator>>() [6/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
AnalyticRigidBodyElement rThis 
)
inline

input stream function

◆ operator>>() [7/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
AnalyticSphericParticle rThis 
)
inline

input stream function

◆ operator>>() [8/135]

std::istream & Kratos::operator>> ( std::istream &  rIStream,
ApplyComponentTableProcess rThis 
)
inline

input stream function

◆ operator>>() [9/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ApplyComponentTableProcessDam rThis 
)
inline

input stream function

◆ operator>>() [10/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ApplyConstantHydrostaticPressureProcess rThis 
)
inline

input stream function

◆ operator>>() [11/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ApplyConstantInterpolateLinePressureProcess rThis 
)
inline

input stream function

◆ operator>>() [12/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ApplyConstantPhreaticMultiLinePressureProcess rThis 
)
inline

input stream function

◆ operator>>() [13/135]

std::istream & Kratos::operator>> ( std::istream &  rIStream,
ApplyDoubleTableProcess rThis 
)
inline

input stream function

◆ operator>>() [14/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ApplyHydrostaticPressureTableProcess rThis 
)
inline

input stream function

◆ operator>>() [15/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ApplyPhreaticMultiLinePressureTableProcess rThis 
)
inline

input stream function

◆ operator>>() [16/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ApplyRigidRotationProcess rThis 
)
inline

input stream function

◆ operator>>() [17/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ApplyWriteScalarProcess rThis 
)
inline

input stream function

◆ operator>>() [18/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
AutomaticDTProcess rThis 
)
inline

input stream function

◆ operator>>() [19/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
BeamParticle rThis 
)
inline

input stream function

◆ operator>>() [20/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
Cluster3D rThis 
)
inline

input stream function

◆ operator>>() [21/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ClusterInformation rThis 
)
inline

◆ operator>>() [22/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ContactInfoSphericParticle rThis 
)
inline

input stream function

◆ operator>>() [23/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ContactMasterSlaveConstraint rThis 
)
inline

input stream function

◆ operator>>() [24/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ControlModule2DProcess rThis 
)
inline

input stream function

◆ operator>>() [25/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ControlModuleProcess rThis 
)
inline

input stream function

◆ operator>>() [26/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ConvectionModel rThis 
)
inline

◆ operator>>() [27/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
CylinderContinuumParticle rThis 
)
inline

input stream function

◆ operator>>() [28/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
CylinderParticle rThis 
)
inline

input stream function

◆ operator>>() [29/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamAddedMassConditionProcess rThis 
)
inline

input stream function

◆ operator>>() [30/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamAzenhaHeatFluxProcess rThis 
)
inline

input stream function

◆ operator>>() [31/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamBofangConditionTemperatureProcess rThis 
)
inline

input stream function

◆ operator>>() [32/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamChemoMechanicalAgingYoungProcess rThis 
)
inline

input stream function

◆ operator>>() [33/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamFixTemperatureConditionProcess rThis 
)
inline

input stream function

◆ operator>>() [34/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamGroutingReferenceTemperatureProcess rThis 
)
inline

input stream function

◆ operator>>() [35/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamHydroConditionLoadProcess rThis 
)
inline

input stream function

◆ operator>>() [36/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamInputTableNodalYoungModulusProcess rThis 
)
inline

input stream function

◆ operator>>() [37/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamNodalReferenceTemperatureProcess rThis 
)
inline

input stream function

◆ operator>>() [38/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamNodalYoungModulusProcess rThis 
)
inline

input stream function

◆ operator>>() [39/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamNoorzaiHeatFluxProcess rThis 
)
inline

input stream function

◆ operator>>() [40/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamRandomFieldsVariableProcess rThis 
)
inline

input stream function

◆ operator>>() [41/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamReservoirConstantTemperatureProcess rThis 
)
inline

input stream function

◆ operator>>() [42/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamReservoirMonitoringTemperatureProcess rThis 
)
inline

input stream function

◆ operator>>() [43/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamTemperaturebyDeviceProcess rThis 
)
inline

input stream function

◆ operator>>() [44/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamTSolAirHeatFluxProcess rThis 
)
inline

input stream function

◆ operator>>() [45/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamUpliftCircularConditionLoadProcess rThis 
)
inline

input stream function

◆ operator>>() [46/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamUpliftConditionLoadProcess rThis 
)
inline

input stream function

◆ operator>>() [47/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DamWestergaardConditionLoadProcess rThis 
)
inline

input stream function

◆ operator>>() [48/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DEMIntegrationScheme rThis 
)
inline

input stream function

◆ operator>>() [49/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DirectConductionBOBComplete rThis 
)
inline

◆ operator>>() [50/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DirectConductionBOBModified rThis 
)
inline

◆ operator>>() [51/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DirectConductionBOBSimple rThis 
)
inline

◆ operator>>() [52/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DirectConductionCollision rThis 
)
inline

◆ operator>>() [53/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DirectConductionModel rThis 
)
inline

◆ operator>>() [54/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DirectConductionPipe rThis 
)
inline

◆ operator>>() [55/135]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
DirectSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

input stream function

◆ operator>>() [56/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
DiscreteElement rThis 
)
inline

input stream function

◆ operator>>() [57/135]

template<class TSolverType , class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
EigenDenseDirectSolver< TSolverType, TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

input stream function

◆ operator>>() [58/135]

template<class TSolverType , class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
EigenDirectSolver< TSolverType, TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

input stream function

◆ operator>>() [59/135]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
EigensystemSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

input stream function

◆ operator>>() [60/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ElementDeactivationProcess rThis 
)
inline

input stream function

◆ operator>>() [61/135]

template<bool TSymmetric, typename TScalarIn , typename TScalarOut >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
FEASTEigensystemSolver< TSymmetric, TScalarIn, TScalarOut > &  rThis 
)
inline

input stream function

◆ operator>>() [62/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ForwardEulerScheme rThis 
)
inline

◆ operator>>() [63/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
GenerationDissipation rThis 
)
inline

◆ operator>>() [64/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
GenerationModel rThis 
)
inline

◆ operator>>() [65/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
GluedToWallScheme rThis 
)
inline

◆ operator>>() [66/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
HeatExchangeMechanism rThis 
)
inline

◆ operator>>() [67/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
HeatGenerationMechanism rThis 
)
inline

◆ operator>>() [68/135]

template<class TPointType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
Hexahedra3D20< TPointType > &  rThis 
)
inline

Input and output input stream function

◆ operator>>() [69/135]

template<class TPointType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
Hexahedra3D27< TPointType > &  rThis 
)
inline

Input and output input stream function

◆ operator>>() [70/135]

template<class TPointType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
Hexahedra3D8< TPointType > &  rThis 
)
inline

Input and output input stream function

◆ operator>>() [71/135]

template<class TPointType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
HexahedraInterface3D8< TPointType > &  rThis 
)
inline

Input and output input stream function

◆ operator>>() [72/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
HybridBashforthScheme rThis 
)
inline

◆ operator>>() [73/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
IceContinuumParticle rThis 
)
inline

input stream function

◆ operator>>() [74/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ImposeZStrainProcess rThis 
)
inline

input stream function

◆ operator>>() [75/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
IndexedPoint rThis 
)
inline

input stream function

◆ operator>>() [76/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
IndirectConductionModel rThis 
)
inline

◆ operator>>() [77/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
IndirectConductionSurroundLayer rThis 
)
inline

◆ operator>>() [78/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
IndirectConductionVargas rThis 
)
inline

◆ operator>>() [79/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
IndirectConductionVoronoiA rThis 
)
inline

◆ operator>>() [80/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
IndirectConductionVoronoiB rThis 
)
inline

◆ operator>>() [81/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
LagrangianRotationProcess rThis 
)
inline

input stream function

◆ operator>>() [82/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
LinearMasterSlaveConstraint rThis 
)
inline

input stream function

◆ operator>>() [83/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
MasterSlaveConstraint rThis 
)
inline

input stream function

◆ operator>>() [84/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
NanoParticle rThis 
)
inline

input stream function

◆ operator>>() [85/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
NusseltGunn rThis 
)
inline

◆ operator>>() [86/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
NusseltHanzMarshall rThis 
)
inline

◆ operator>>() [87/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
NusseltLiMason rThis 
)
inline

◆ operator>>() [88/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
NusseltWhitaker rThis 
)
inline

◆ operator>>() [89/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
PeriodicInterfaceProcess rThis 
)
inline

input stream function

◆ operator>>() [90/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
PolyhedronSkinSphericParticle rThis 
)
inline

input stream function

◆ operator>>() [91/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
PoromechanicsFaceLoadControlModuleProcess rThis 
)
inline

input stream function

◆ operator>>() [92/135]

template<class TPointType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
Prism3D15< TPointType > &  rThis 
)
inline

input stream function

Input and output

◆ operator>>() [93/135]

template<class TPointType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
Prism3D6< TPointType > &  rThis 
)
inline

input stream function

Input and output

◆ operator>>() [94/135]

template<class TPointType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
Quadrilateral2D8< TPointType > &  rThis 
)
inline

Input and output input stream function

◆ operator>>() [95/135]

template<class TPointType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
Quadrilateral2D9< TPointType > &  rThis 
)
inline

input stream function

Input and output

◆ operator>>() [96/135]

template<class TPointType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
Quadrilateral3D8< TPointType > &  rThis 
)
inline

Input and output input stream function

◆ operator>>() [97/135]

template<class TPointType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
Quadrilateral3D9< TPointType > &  rThis 
)
inline

Input and output input stream function

◆ operator>>() [98/135]

template<class T >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
Quaternion< T > &  rThis 
)
inline

◆ operator>>() [99/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
QuaternionIntegrationScheme rThis 
)
inline

◆ operator>>() [100/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
RadiationContinuumKrause rThis 
)
inline

◆ operator>>() [101/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
RadiationContinuumZhou rThis 
)
inline

◆ operator>>() [102/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
RadiationModel rThis 
)
inline

◆ operator>>() [103/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
RealContactLu rThis 
)
inline

◆ operator>>() [104/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
RealContactModel rThis 
)
inline

◆ operator>>() [105/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
RealContactMorris rThis 
)
inline

◆ operator>>() [106/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
RealContactZhou rThis 
)
inline

◆ operator>>() [107/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
RetentionLaw rThis 
)
inline

input stream function

◆ operator>>() [108/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
RigidBodyElement3D rThis 
)
inline

input stream function

◆ operator>>() [109/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
RungeKuttaScheme rThis 
)
inline

◆ operator>>() [110/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
SetAutomatedInitialDamageProcess rThis 
)
inline

input stream function

◆ operator>>() [111/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
SetAutomatedInitialVariableProcess rThis 
)
inline

input stream function

◆ operator>>() [112/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
SetCartesianLocalAxesProcess rThis 
)
inline

input stream function

◆ operator>>() [113/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
SetCylindricalLocalAxesProcess rThis 
)
inline

input stream function

◆ operator>>() [114/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
SetDummyPropertyForRigidElementsProcess rThis 
)
inline

input stream function

◆ operator>>() [115/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
SetMaterialPropertiesForThermalCouplingProcess rThis 
)
inline

input stream function

◆ operator>>() [116/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
SetMeshVelocityForThermalCouplingProcess rThis 
)
inline

input stream function

◆ operator>>() [117/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
SetSphericalLocalAxesProcess rThis 
)
inline

input stream function

◆ operator>>() [118/135]

std::istream & Kratos::operator>> ( std::istream &  rIStream,
ShellCrossSection rThis 
)
inline

◆ operator>>() [119/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ShipElement3D rThis 
)
inline

input stream function

◆ operator>>() [120/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
SingleSphereCluster3D rThis 
)
inline

input stream function

◆ operator>>() [121/135]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
SkylineLUFactorizationSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

input stream function

◆ operator>>() [122/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
SlipConstraint rThis 
)
inline

input stream function

◆ operator>>() [123/135]

template<class TSparseSpaceType , class TDenseSpaceType , class TReordererType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
SpectraSymGEigsShiftSolver< TSparseSpaceType, TDenseSpaceType, TReordererType > &  rThis 
)
inline

input stream function

◆ operator>>() [124/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
SphericContinuumParticle rThis 
)
inline

input stream function

◆ operator>>() [125/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
SphericParticle rThis 
)
inline

input stream function

◆ operator>>() [126/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
SymplecticEulerOldVelocityScheme rThis 
)
inline

◆ operator>>() [127/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
SymplecticEulerScheme rThis 
)
inline

◆ operator>>() [128/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
TaylorScheme rThis 
)
inline

◆ operator>>() [129/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
TerminalVelocityScheme rThis 
)
inline

◆ operator>>() [130/135]

template<class TPointType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
Tetrahedra3D4< TPointType > &  rThis 
)
inline

Input and output input stream function

◆ operator>>() [131/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ThermalDEMIntegrationScheme rThis 
)
inline

◆ operator>>() [132/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ThermalForwardEulerScheme rThis 
)
inline

◆ operator>>() [133/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
ThermalSphericParticle rThis 
)
inline

◆ operator>>() [134/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
UpdateThermalModelPartProcess rThis 
)
inline

input stream function

◆ operator>>() [135/135]

std::istream& Kratos::operator>> ( std::istream &  rIStream,
VelocityVerletScheme rThis 
)
inline

◆ operator|()

Flags Kratos::operator| ( const Flags Left,
const Flags Right 
)

◆ outer_prod()

template<typename TExpression1Type , typename TExpression2Type , std::size_t TCategory1, std::size_t TCategory2>
AMatrix::VectorOuterProductExpression<TExpression1Type, TExpression2Type> Kratos::outer_prod ( AMatrix::MatrixExpression< TExpression1Type, TCategory1 > const &  First,
AMatrix::MatrixExpression< TExpression2Type, TCategory2 > const &  Second 
)

◆ ParallelEnvironment::RegisterCommunicatorFactory< const std::string >()

template void Kratos::ParallelEnvironment::RegisterCommunicatorFactory< const std::string > ( std::function< Communicator::UniquePointer(ModelPart &, const std::string &)>  CommunicatorFactory)

◆ ParallelEnvironment::RegisterFillCommunicatorFactory< const std::string >()

template void Kratos::ParallelEnvironment::RegisterFillCommunicatorFactory< const std::string > ( std::function< FillCommunicator::Pointer(ModelPart &, const std::string &)>  CommunicatorFactory)

◆ prod()

template<typename TExpression1Type , typename TExpression2Type , std::size_t TCategory1, std::size_t TCategory2>
AMatrix::MatrixProductExpression<TExpression1Type, TExpression2Type> Kratos::prod ( AMatrix::MatrixExpression< TExpression1Type, TCategory1 > const &  First,
AMatrix::MatrixExpression< TExpression2Type, TCategory2 > const &  Second 
)

◆ ReadMatrixMarketMatrix()

template<typename CompressedMatrixType >
bool Kratos::ReadMatrixMarketMatrix ( const char *  FileName,
CompressedMatrixType &  M 
)
inline

◆ ReadMatrixMarketMatrixEntry() [1/2]

bool Kratos::ReadMatrixMarketMatrixEntry ( FILE *  f,
int I,
int J,
double V 
)
inline

◆ ReadMatrixMarketMatrixEntry() [2/2]

bool Kratos::ReadMatrixMarketMatrixEntry ( FILE *  f,
int I,
int J,
std::complex< double > &  V 
)
inline

◆ ReadMatrixMarketVector()

template<typename VectorType >
bool Kratos::ReadMatrixMarketVector ( const char *  FileName,
VectorType V 
)
inline

◆ ReadMatrixMarketVectorEntry() [1/2]

bool Kratos::ReadMatrixMarketVectorEntry ( FILE *  f,
double entry 
)
inline

◆ ReadMatrixMarketVectorEntry() [2/2]

bool Kratos::ReadMatrixMarketVectorEntry ( FILE *  f,
std::complex< double > &  entry 
)
inline

◆ RegisterTrilinosLinearSolvers()

void Kratos::RegisterTrilinosLinearSolvers ( )

◆ row() [1/2]

template<typename TExpressionType , std::size_t TCategory>
AMatrix::MatrixRow<TExpressionType> Kratos::row ( AMatrix::MatrixExpression< TExpressionType, TCategory > &  TheExpression,
std::size_t  RowIndex 
)

◆ row() [2/2]

template<typename TExpressionType , std::size_t TCategory>
AMatrix::MatrixRow<const TExpressionType> Kratos::row ( AMatrix::MatrixExpression< TExpressionType, TCategory > const &  TheExpression,
std::size_t  RowIndex 
)

◆ SensitivityUtilities::AssignEntityDerivativesToNodes< ModelPart::ConditionsContainerType >()

template void Kratos::SensitivityUtilities::AssignEntityDerivativesToNodes< ModelPart::ConditionsContainerType > ( ModelPart ,
const int  ,
const Variable< Matrix > &  ,
const std::unordered_map< int, std::vector< int >> &  ,
const double  ,
const Flags ,
const bool   
)

◆ SensitivityUtilities::AssignEntityDerivativesToNodes< ModelPart::ElementsContainerType >()

template void Kratos::SensitivityUtilities::AssignEntityDerivativesToNodes< ModelPart::ElementsContainerType > ( ModelPart ,
const int  ,
const Variable< Matrix > &  ,
const std::unordered_map< int, std::vector< int >> &  ,
const double  ,
const Flags ,
const bool   
)

◆ SensitivityUtilities::GetContainer< ModelPart::ConditionsContainerType >()

template<>
ModelPart::ConditionsContainerType& Kratos::SensitivityUtilities::GetContainer< ModelPart::ConditionsContainerType > ( ModelPart rModelPart)

◆ SensitivityUtilities::GetContainer< ModelPart::ElementsContainerType >()

template<>
ModelPart::ElementsContainerType& Kratos::SensitivityUtilities::GetContainer< ModelPart::ElementsContainerType > ( ModelPart rModelPart)

◆ SetIntersection()

SpaceTimeSet::Pointer Kratos::SetIntersection ( SpaceTimeSet::Pointer  set_1,
SpaceTimeSet::Pointer  set_2 
)

◆ SetMatrixMarketValueTypeCode() [1/2]

void Kratos::SetMatrixMarketValueTypeCode ( MM_typecode mm_code,
const double value 
)
inline

◆ SetMatrixMarketValueTypeCode() [2/2]

void Kratos::SetMatrixMarketValueTypeCode ( MM_typecode mm_code,
const std::complex< double > &  value 
)
inline

◆ SetUnion()

SpaceTimeSet::Pointer Kratos::SetUnion ( SpaceTimeSet::Pointer  set_1,
SpaceTimeSet::Pointer  set_2 
)

◆ SortSubModelPartsByName()

bool Kratos::SortSubModelPartsByName ( ModelPart A,
ModelPart B 
)

◆ SplitNodesIntoLocalAndGhost()

void Kratos::SplitNodesIntoLocalAndGhost ( ModelPart::NodesContainerType const &  rNodes,
std::vector< ModelPart::NodeType * > &  rLocalNodes,
std::vector< ModelPart::NodeType * > &  rGhostNodes 
)

◆ subrange() [1/2]

template<typename TExpressionType , std::size_t TCategory>
AMatrix::SubVector<TExpressionType> Kratos::subrange ( AMatrix::MatrixExpression< TExpressionType, TCategory > &  TheExpression,
std::size_t  From,
std::size_t  To 
)

◆ subrange() [2/2]

template<typename TExpressionType , std::size_t TCategory>
AMatrix::SubVector<const TExpressionType> Kratos::subrange ( AMatrix::MatrixExpression< TExpressionType, TCategory > const &  TheExpression,
std::size_t  From,
std::size_t  To 
)

◆ sum()

template<typename TExpressionType , std::size_t TCategory>
TExpressionType::data_type Kratos::sum ( AMatrix::MatrixExpression< TExpressionType, TCategory > const &  TheExpression)

◆ TimeAveragingProcess::CalculateTimeIntegratedNonHistoricalQuantity< double, ModelPart::ElementsContainerType >()

template void Kratos::TimeAveragingProcess::CalculateTimeIntegratedNonHistoricalQuantity< double, ModelPart::ElementsContainerType > ( ModelPart::ElementsContainerType ,
const Variable< double > &  ,
const Variable< double > &  ,
const double   
) const

◆ TimeAveragingProcess::CalculateTimeIntegratedNonHistoricalQuantity< double, ModelPart::NodesContainerType >()

template void Kratos::TimeAveragingProcess::CalculateTimeIntegratedNonHistoricalQuantity< double, ModelPart::NodesContainerType > ( ModelPart::NodesContainerType ,
const Variable< double > &  ,
const Variable< double > &  ,
const double   
) const

◆ trans() [1/2]

template<typename T >
AMatrix::TransposeMatrix<const T> Kratos::trans ( const T &  TheMatrix)

◆ trans() [2/2]

template<typename T >
AMatrix::TransposeMatrix<T> Kratos::trans ( T &  TheMatrix)

◆ triangulate()

void Kratos::triangulate ( char *  ,
struct triangulateio *  ,
struct triangulateio *  ,
struct triangulateio *   
)

◆ trifree()

void Kratos::trifree ( void *  )

◆ VariableRedistributionUtility::ConsistentMassMatrix< GeometryData::KratosGeometryFamily::Kratos_Linear, 2 >()

template<>
void Kratos::VariableRedistributionUtility::ConsistentMassMatrix< GeometryData::KratosGeometryFamily::Kratos_Linear, 2 > ( BoundedMatrix< double, 2, 2 > &  rMassMatrix)

◆ VariableRedistributionUtility::ConsistentMassMatrix< GeometryData::KratosGeometryFamily::Kratos_Quadrilateral, 4 >()

template<>
void Kratos::VariableRedistributionUtility::ConsistentMassMatrix< GeometryData::KratosGeometryFamily::Kratos_Quadrilateral, 4 > ( BoundedMatrix< double, 4, 4 > &  rMassMatrix)

◆ VariableRedistributionUtility::ConsistentMassMatrix< GeometryData::KratosGeometryFamily::Kratos_Triangle, 3 >()

template<>
void Kratos::VariableRedistributionUtility::ConsistentMassMatrix< GeometryData::KratosGeometryFamily::Kratos_Triangle, 3 > ( BoundedMatrix< double, 3, 3 > &  rMassMatrix)

◆ VariableUtils::GetContainer< ModelPart::ConditionsContainerType >() [1/2]

template<>
const ModelPart::ConditionsContainerType& Kratos::VariableUtils::GetContainer< ModelPart::ConditionsContainerType > ( const ModelPart rModelPart)

◆ VariableUtils::GetContainer< ModelPart::ConditionsContainerType >() [2/2]

template<>
ModelPart::ConditionsContainerType& Kratos::VariableUtils::GetContainer< ModelPart::ConditionsContainerType > ( ModelPart rModelPart)

◆ VariableUtils::GetContainer< ModelPart::ElementsContainerType >() [1/2]

template<>
const ModelPart::ElementsContainerType& Kratos::VariableUtils::GetContainer< ModelPart::ElementsContainerType > ( const ModelPart rModelPart)

◆ VariableUtils::GetContainer< ModelPart::ElementsContainerType >() [2/2]

template<>
ModelPart::ElementsContainerType& Kratos::VariableUtils::GetContainer< ModelPart::ElementsContainerType > ( ModelPart rModelPart)

◆ VariableUtils::GetContainer< ModelPart::NodesContainerType >() [1/2]

template<>
const ModelPart::NodesContainerType& Kratos::VariableUtils::GetContainer< ModelPart::NodesContainerType > ( const ModelPart rModelPart)

◆ VariableUtils::GetContainer< ModelPart::NodesContainerType >() [2/2]

template<>
ModelPart::NodesContainerType& Kratos::VariableUtils::GetContainer< ModelPart::NodesContainerType > ( ModelPart rModelPart)

◆ VariableUtils::GetCurrentPositionsVector< std::vector< double > >()

template std::vector<double> Kratos::VariableUtils::GetCurrentPositionsVector< std::vector< double > > ( const ModelPart::NodesContainerType ,
const unsigned int  Dimension 
)

◆ VariableUtils::GetInitialPositionsVector< std::vector< double > >()

template std::vector<double> Kratos::VariableUtils::GetInitialPositionsVector< std::vector< double > > ( const ModelPart::NodesContainerType ,
const unsigned int  Dimension 
)

◆ VariableUtils::WeightedAccumulateVariableOnNodes< double, ModelPart::ConditionsContainerType, double >()

◆ VariableUtils::WeightedAccumulateVariableOnNodes< double, ModelPart::ConditionsContainerType, int >()

◆ VariableUtils::WeightedAccumulateVariableOnNodes< double, ModelPart::ElementsContainerType, double >()

◆ VariableUtils::WeightedAccumulateVariableOnNodes< double, ModelPart::ElementsContainerType, int >()

◆ VtuOutput::AddContainerExpression< ModelPart::ConditionsContainerType >()

◆ VtuOutput::AddContainerExpression< ModelPart::ElementsContainerType >()

◆ VtuOutput::AddContainerExpression< ModelPart::NodesContainerType >()

template void Kratos::VtuOutput::AddContainerExpression< ModelPart::NodesContainerType > ( const std::string &  ,
const typename ContainerExpression< ModelPart::NodesContainerType >::Pointer   
)

◆ WriteMatrixMarketMatrix()

template<typename CompressedMatrixType >
bool Kratos::WriteMatrixMarketMatrix ( const char *  FileName,
CompressedMatrixType &  M,
bool  Symmetric 
)
inline

◆ WriteMatrixMarketMatrixEntry() [1/2]

int Kratos::WriteMatrixMarketMatrixEntry ( FILE *  f,
int  I,
int  J,
const double entry 
)
inline

◆ WriteMatrixMarketMatrixEntry() [2/2]

int Kratos::WriteMatrixMarketMatrixEntry ( FILE *  f,
int  I,
int  J,
const std::complex< double > &  entry 
)
inline

◆ WriteMatrixMarketVector()

template<typename VectorType >
bool Kratos::WriteMatrixMarketVector ( const char *  FileName,
VectorType V 
)
inline

◆ WriteMatrixMarketVectorEntry() [1/2]

int Kratos::WriteMatrixMarketVectorEntry ( FILE *  f,
const double entry 
)
inline

◆ WriteMatrixMarketVectorEntry() [2/2]

int Kratos::WriteMatrixMarketVectorEntry ( FILE *  f,
const std::complex< double > &  entry 
)
inline

Variable Documentation

◆ bool

REACTION_CHECK_STIFFNESS_FACTOR INNER_LOOP_ITERATION DISTANCE_THRESHOLD ACTIVE_CHECK_FACTOR AUXILIAR_COORDINATES NORMAL_GAP WEIGHTED_GAP WEIGHTED_SCALAR_RESIDUAL ACTIVE_SET_COMPUTED SLIP_SET_CONVERGED SLIP_AUGMENTATION_COEFFICIENT LAGRANGE_MULTIPLIER_CONTACT_PRESSURE AUGMENTED_TANGENT_CONTACT_PRESSURE Kratos::bool

◆ double

TOPOGRAPHY RAIN CHEZY Kratos::double

◆ GidIO< GidGaussPointsContainer, GidMeshContainer >

◆ HAS_ROTATION

PARTICLE_COHESION I33 BEAM_INERTIA_ROT_UNIT_LENGHT_Y KRATOS_CREATE_VARIABLE (double, BEAM_INERTIA_ROT_UNIT_LENGHT_Z) typedef std K_ALPHA NEIGHBOUR_PARTICLE_OF_RIGID_FACE Kratos::HAS_ROTATION

◆ int

REACTION_CHECK_STIFFNESS_FACTOR Kratos::int

◆ KratosComponents< ComplexDenseLinearSolverFactoryType >

◆ KratosComponents< ComplexLinearSolverFactoryType >

◆ KratosComponents< Condition >

◆ KratosComponents< ConstitutiveLaw >

◆ KratosComponents< DataCommunicator >

◆ KratosComponents< DenseLinearSolverFactoryType >

◆ KratosComponents< Element >

◆ KratosComponents< ExplicitBuilderType >

◆ KratosComponents< Flags >

◆ KratosComponents< Geometry< Node > >

◆ KratosComponents< LinearSolverFactoryType >

◆ KratosComponents< MasterSlaveConstraint >

◆ KratosComponents< Modeler >

◆ KratosComponents< PreconditionerFactoryType >

◆ KratosComponents< TrilinosLinearSolverFactoryType >

◆ KratosComponents< Variable< array_1d< double, 3 > > >

◆ KratosComponents< Variable< array_1d< double, 4 > > >

◆ KratosComponents< Variable< array_1d< double, 6 > > >

◆ KratosComponents< Variable< array_1d< double, 9 > > >

◆ KratosComponents< Variable< bool > >

◆ KratosComponents< Variable< double > >

◆ KratosComponents< Variable< Flags > >

◆ KratosComponents< Variable< int > >

◆ KratosComponents< Variable< Matrix > >

◆ KratosComponents< Variable< Quaternion< double > > >

◆ KratosComponents< Variable< unsigned int > >

KRATOS_API_EXTERN template class Kratos::KratosComponents< Variable< unsigned int > >

◆ KratosComponents< Variable< Vector > >

◆ LARGE

constexpr double Kratos::LARGE = 1.0e10
constexpr

◆ mcalculation_model_part

ModelPart& Kratos::mcalculation_model_part

◆ mMmgDisp

MMG5_pSol Kratos::mMmgDisp

The solution variable for MMG.

◆ mMmgMesh

MMG5_pMesh Kratos::mMmgMesh

◆ mMmgMet

MMG5_pSol Kratos::mMmgMet

The mesh data from MMG.

◆ mMmgSol

MMG5_pSol Kratos::mMmgSol

The metric variable for MMG.

◆ mNode0ID2D

constexpr static std::array<unsigned int, 3> Kratos::mNode0ID2D = {1, 2, 0}
staticconstexpr

◆ mNode0ID3D

constexpr static std::array<unsigned int, 4> Kratos::mNode0ID3D = {2, 0, 0, 0}
staticconstexpr

◆ mNode1ID2D

constexpr static std::array<unsigned int, 3> Kratos::mNode1ID2D = {2, 0, 1}
staticconstexpr

◆ mNode1ID3D

constexpr static std::array<unsigned int, 4> Kratos::mNode1ID3D = {3, 3, 1, 2}
staticconstexpr

◆ mNode2ID3D

constexpr static std::array<unsigned int, 4> Kratos::mNode2ID3D = {1, 2, 3, 1}
staticconstexpr

◆ mParMmgMesh

PMMG_pParMesh Kratos::mParMmgMesh

◆ mpBinsObjectDynamic

BinsObjectDynamic<Configure>::Pointer Kratos::mpBinsObjectDynamic

◆ msExplicitBuilder

ExplicitBuilderType Kratos::msExplicitBuilder
static

◆ msGeometryDimension

template<class TContainerPointType , class TContainerPointEmbeddedType >
const GeometryData SurfaceInNurbsVolumeGeometry<TWorkingSpaceDimension, TVolumeContainerPointType>::msGeometryData & Kratos::msGeometryDimension

◆ mtopographic_model_part

ModelPart& Kratos::mtopographic_model_part

◆ N_DIM_1D

constexpr SizeType Kratos::N_DIM_1D = 1
constexpr

◆ N_DIM_2D

constexpr SizeType Kratos::N_DIM_2D = 2
constexpr

◆ N_DIM_3D

constexpr SizeType Kratos::N_DIM_3D = 3
constexpr

◆ normalComponentNumber

constexpr int Kratos::normalComponentNumber = 0
constexpr

◆ PORE_PRESSURE_SIGN_FACTOR

constexpr double Kratos::PORE_PRESSURE_SIGN_FACTOR = 1.0
constexpr

◆ STRESS_TENSOR_SIZE_2D

constexpr SizeType Kratos::STRESS_TENSOR_SIZE_2D = 3
constexpr

◆ STRESS_TENSOR_SIZE_3D

constexpr SizeType Kratos::STRESS_TENSOR_SIZE_3D = 3
constexpr

◆ tangentialComponentNumber

constexpr int Kratos::tangentialComponentNumber = 1
constexpr

◆ ThreadFixedSizeMemoryPoolLock

std::atomic_flag Kratos::ThreadFixedSizeMemoryPoolLock = ATOMIC_FLAG_INIT

◆ TINY

constexpr double Kratos::TINY = 1.0e-60
constexpr

◆ VOIGT_SIZE_2D_AXISYMMETRIC

constexpr SizeType Kratos::VOIGT_SIZE_2D_AXISYMMETRIC = 4
constexpr

◆ VOIGT_SIZE_2D_INTERFACE

constexpr SizeType Kratos::VOIGT_SIZE_2D_INTERFACE = 2
constexpr

◆ VOIGT_SIZE_2D_PLANE_STRAIN

constexpr SizeType Kratos::VOIGT_SIZE_2D_PLANE_STRAIN = 4
constexpr

◆ VOIGT_SIZE_2D_PLANE_STRESS

constexpr SizeType Kratos::VOIGT_SIZE_2D_PLANE_STRESS = 3
constexpr

◆ VOIGT_SIZE_3D

constexpr SizeType Kratos::VOIGT_SIZE_3D = 6
constexpr

◆ VOIGT_SIZE_3D_INTERFACE

constexpr SizeType Kratos::VOIGT_SIZE_3D_INTERFACE = 3
constexpr