|
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 |
|
|
| 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::ElementsContainerType & | SensitivityUtilities::GetContainer< ModelPart::ElementsContainerType > (ModelPart &rModelPart) |
|
template<> |
ModelPart::ConditionsContainerType & | SensitivityUtilities::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::NodesContainerType & | VariableUtils::GetContainer< ModelPart::NodesContainerType > (ModelPart &rModelPart) |
|
template<> |
ModelPart::ElementsContainerType & | VariableUtils::GetContainer< ModelPart::ElementsContainerType > (ModelPart &rModelPart) |
|
template<> |
ModelPart::ConditionsContainerType & | VariableUtils::GetContainer< ModelPart::ConditionsContainerType > (ModelPart &rModelPart) |
|
template<> |
const ModelPart::NodesContainerType & | VariableUtils::GetContainer< ModelPart::NodesContainerType > (const ModelPart &rModelPart) |
|
template<> |
const ModelPart::ElementsContainerType & | VariableUtils::GetContainer< ModelPart::ElementsContainerType > (const ModelPart &rModelPart) |
|
template<> |
const ModelPart::ConditionsContainerType & | VariableUtils::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< double > | VariableUtils::GetInitialPositionsVector< std::vector< double > > (const ModelPart::NodesContainerType &, const unsigned int Dimension) |
|
template std::vector< double > | VariableUtils::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< ElementsContainerType > | FactorElements (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< ConditionsContainerType > | FactorConditions (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) |
|
|
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) |
|
|
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...
|
|
|
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) |
|
|
bool | operator<< (Chunk const &rFirst, Chunk const &rSedond) |
|
std::ostream & | operator<< (std::ostream &rOStream, const Chunk &rThis) |
| output stream function More...
|
|
|
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_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) |
|
|
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...
|
|
|
| KRATOS_CREATE_LOCAL_FLAG (IntegrationInfo, DO_NOT_CREATE_TESSELLATION_ON_SLAVE, 0) |
|