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

The Kratos core comprises a basic set of classes used by all applications. More...

Collaboration diagram for Kratos Core:

Classes

class  Kratos::DistributedCsrMatrix< TDataType, TIndexType >
 This class implements "serial" CSR matrix, including capabilities for FEM assembly. More...
 
class  Kratos::DistributedNumbering< TIndexType >
 This function provides essential capabilities for mapping between local and global ids in a distributed vector. More...
 
class  Kratos::DistributedVectorExporter< TIndexType >
 Provides a DistributedVectorExporter which implements FEM assemble capabilities. More...
 
class  Kratos::EdgeBasedDataStructure< TDim >
 
class  Kratos::GlobalPointersVector< TDataType >
 This class is a vector which stores global pointers. More...
 
class  Kratos::Model
 This class aims to manage different model parts across multi-physics simulations. More...
 
class  Kratos::NodalData
 Stores all data and dofs which are stored in each elements. More...
 
class  Kratos::SparseContiguousRowGraph< TIndexType >
 Short class definition. More...
 
class  Kratos::EdgeBasedGradientRecoveryElement< TDim >
 An element to compute the a nodal variable from an embedded skin. More...
 
class  Kratos::EmbeddedNodalVariableCalculationElementSimplex< TVarType >
 An element to compute the a nodal variable from an embedded skin. More...
 
class  Kratos::BoundingBox< TPointType >
 Representing a bounding box by storing the min and max points. More...
 
class  Kratos::Accessor
 This class defines the way a certain property is accessed. More...
 
class  Kratos::Chunk
 Chunk is the smallest building block of Kratos memory management. More...
 
class  Kratos::CodeLocation
 
class  Kratos::Exception
 Extends the std::exception class with more information about error location. More...
 
class  Kratos::FixedSizeMemoryPool
 FixedSizeMemoryPool is the multi-thread manager of Kratos memory management. More...
 
class  Kratos::GlobalPointer< TDataType >
 This class is a wrapper for a pointer to a data that is located in a different rank. More...
 
struct  Kratos::GlobalPointerHasher< TDataType >
 Template struct for hashing GlobalPointer instances. More...
 
struct  Kratos::GlobalPointerComparor< TDataType >
 This is a key comparer between two dof pointers checking for equal keys. More...
 
struct  Kratos::GlobalPointerCompare< TDataType >
 This is a key compare between two pointers to the object object. More...
 
class  Kratos::InitialState
 Define the initial state of the material in terms of initial stress/strain/F. More...
 
struct  Kratos::KeyComparorRange< TClassType >
 This is a key comparer of general pourpose between two classes. More...
 
struct  Kratos::KeyHasherRange< TClassType >
 This is a hasher of general pourpose. More...
 
struct  Kratos::VariableHasher
 This is a hasher for variables. More...
 
struct  Kratos::VariableComparator
 This is a key comparer between two variables. More...
 
struct  Kratos::pVariableHasher
 This is a hasher for variables pointers. More...
 
struct  Kratos::pVariableComparator
 This is a key comparer between two variables pointers. More...
 
struct  Kratos::IndexedObjectHasher< TIndexedObject >
 This is a hasher for indexed objects. More...
 
struct  Kratos::IndexedObjectComparator< TIndexedObject >
 This is a key comparer between two indexed objects. More...
 
struct  Kratos::IndexedObjectPointerHasher< TpIndexedObject >
 This is a hasher for indexed objects (pointer) More...
 
struct  Kratos::IndexedObjectPointerComparator< TpIndexedObject >
 This is a key comparer between two indexed objects (pointer) More...
 
struct  Kratos::SharedPointerHasher< TSharedPointer >
 This is a hasher for shared pointers. More...
 
struct  Kratos::SharedPointerComparator< TSharedPointer >
 This is a key comparer between two shared pointers. More...
 
struct  Kratos::VectorIndexHasher< TVectorIndex >
 This is a hasher between two vectors of indexes. More...
 
struct  Kratos::VectorIndexComparor< TVectorIndex >
 This is a key comparer between two vectors of indexes. More...
 
struct  Kratos::DofPointerHasher
 This is a hasher for a dof pointers. More...
 
struct  Kratos::DofPointerComparor
 This is a key comparer between two dof pointers. More...
 
struct  Kratos::PairHasher< TType1, TType2 >
 This is a hasher for pairs. More...
 
struct  Kratos::PairComparor< TType1, TType2 >
 This is a key comparer between two indexes pairs. More...
 
struct  std::hash< std::pair< T1, T2 > >
 This is a hasher for pairs. More...
 
class  Kratos::Parameters
 This class provides to Kratos a data structure for I/O based on the standard of JSON. More...
 
class  Kratos::MergeVariableListsUtility
 Merges the variable lists of the input modelparts. More...
 
class  Kratos::NearestPointUtilities
 Tools to calculate the nearest point in different geometries. More...
 
class  Kratos::CoordinateTransformationUtils< TLocalMatrixType, TLocalVectorType, TValueType >
 
class  Kratos::Testing::Tester
 Tester class manages all tests and provide interface to run them. More...
 
class  Kratos::TestSkippedException
 Exception type used to signal that a test should be skipped. More...
 
class  Kratos::Testing::TestCase
 The test case base class. More...
 
class  Kratos::GeometricalObjectsBins
 A bins container for 3 dimensional GeometricalObject entities. More...
 
class  Kratos::MixedGenericCriteria< TSparseSpace, TDenseSpace >
 Convergence criteria for mixed vector-scalar problems. More...
 
class  Kratos::SubModelPartSkinDetectionProcess< TDim >
 Create a SubModelPart covering a part of the outside skin of the computation domain where a condition is met. More...
 
class  Kratos::ReorderAndOptimizeModelPartProcess
 Short class definition. More...
 
class  Kratos::MeshCoarseningProcess
 Short class definition. More...
 
class  Kratos::Internals::DistanceSpatialContainersConfigure
 This class contains the tools related with the distance spatial container cell data. More...
 
class  Kratos::Internals::DistanceSpatialContainersConfigure::CellNodeData
 This class contains the cell node data. More...
 
class  Kratos::FindIntersectedGeometricalObjectsProcess
 This class takes two modelparts and marks the intersected ones with SELECTED flag. More...
 
class  Kratos::OutputProcess
 The base class for output processes. More...
 
class  Kratos::StructuredMeshGeneratorProcess
 Short class definition. More...
 
class  Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >
 Base class for convergence accelerators This class is intended to be the base of any convergence accelerator in Kratos. More...
 
class  Kratos::ResidualBasedIncrementalAitkenStaticScheme< TSparseSpace, TDenseSpace >
 A scheme for the solution of a problem using Aitken iterations. More...
 
class  Kratos::Testing::DistributedTestCase
 Base class for distributed tests. More...
 
class  Kratos::Testing::TestCaseResult
 The test case base class. More...
 
class  Kratos::Testing::TestSuite
 This class holds an array of test cases and run them one by one in its Run method. More...
 
class  Kratos::BruteForcePointLocator
 Utility class to find an entity of a mesh based on a location. More...
 
class  Kratos::DofUpdater< TSparseSpace >
 Utility class to update the values of degree of freedom (Dof) variables after solving the system. More...
 
class  Kratos::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  Kratos::ModelPartGraphUtilities
 This file computes the graph representing the connectivity of a modelpart. More...
 
class  Kratos::RVEPeriodicityUtility
 This defines a class to define periodic BC to a RVE. More...
 
class  Kratos::HCFDataContainer
 Defining all the methods and variables required in fatigue simulations. More...
 
class  Kratos::TrilinosResidualBasedIncrementalAitkenStaticScheme< TSparseSpace, TDenseSpace >
 A scheme for the solution of a problem using Aitken iterations. More...
 
class  Kratos::MeshCondition
 This is pure geometric condition. The only purpose for this definition is to create dummy conditions. More...
 
class  Kratos::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  Kratos::PointerVectorSet< TDataType, TGetKeyType, TCompareType, TEqualType, TPointerType, TContainerType >
 A sorted associative container similar to an STL set, but uses a vector to store pointers to its data. More...
 
class  Kratos::VariablesListDataValueContainer
 A shared variable list gives the position of each variable in the containers sharing it. More...
 
class  Temporal
 A temporal controller to control behavior based on temporal values. More...
 
class  Kratos::FactoryBase
 Here we define some common methods. More...
 
class  Kratos::LinearSolverFactory< TSparseSpace, TLocalSpace >
 Here we add the functions needed for the registration of linear solvers. More...
 
class  Kratos::StandardLinearSolverFactory< TSparseSpace, TLocalSpace, TLinearSolverType >
 Here we add the functions needed for the registration of linear solvers. More...
 
class  Kratos::BrepCurve< TContainerPointType, TContainerPointEmbeddedType >
 The BrepCurve acts as topology for curves. Those can be enclosed by a certain set of points. More...
 
class  Kratos::BrepSurface< TContainerPointType, TContainerPointEmbeddedType >
 The BrepSurface acts as topology for faces. Those can be enclosed by a certain set of brep face curves. More...
 
class  Kratos::Hexahedra3D20< TPointType >
 A twenty node hexahedra geometry with serendipity shape functions. More...
 
class  Kratos::Hexahedra3D8< TPointType >
 An eight node hexahedra geometry with linear shape functions. More...
 
class  Kratos::Line2D3< TPointType >
 An three node 2D line geometry with quadratic shape functions. More...
 
class  Kratos::Line2D5< TPointType >
 An five node 2D line geometry with quartic shape functions. More...
 
class  Kratos::Line3D3< TPointType >
 An three node 3D line geometry with quadratic shape functions. More...
 
class  Kratos::NurbsVolumeGeometry< TContainerPointType >
 A volume geometry based on a full 3-dimensional BSpline tensor product. More...
 
class  Kratos::Prism3D15< TPointType >
 A fifteen node prism geometry with quadratic shape functions. More...
 
class  Kratos::Pyramid3D13< TPointType >
 A 13 node pyramid geometry with quadratic shape functions. More...
 
class  Kratos::QuadraturePointGeometry< TPointType, TWorkingSpaceDimension, TLocalSpaceDimension, TDimension >
 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  Kratos::Quadrilateral2D4< TPointType >
 A four node 2D quadrilateral geometry with bi-linear shape functions. More...
 
class  Kratos::Quadrilateral2D9< TPointType >
 A nine node 2D quadrilateral geometry with quadratic shape functions. More...
 
class  Kratos::Quadrilateral3D8< TPointType >
 A eight node 3D quadrilateral geometry with quadratic shape functions. More...
 
class  Kratos::Tetrahedra3D10< TPointType >
 A ten node tetrahedra geometry with quadratic shape functions. More...
 
class  Kratos::Triangle2D10< TPointType >
 A ten node 2D triangular geometry with cubic shape functions. More...
 
class  Kratos::Triangle2D3< TPointType >
 A three node 2D triangle geometry with linear shape functions. More...
 
class  Kratos::Triangle3D3< TPointType >
 A three node 3D triangle geometry with linear shape functions. More...
 
class  Kratos::FillCommunicator
 Base class defining the API for the fill communicator utilities. More...
 
class  Kratos::FNV1a64Hash
 A constexpr version of FNV hash function. (64 bit version) More...
 
class  Kratos::GidIOBase
 Base class for GidIO. More...
 
class  Kratos::IndexedObject
 This object defines an indexed object. More...
 
class  Kratos::KratosApplication
 This class defines the interface with kernel for all applications in Kratos. More...
 
class  Kratos::KratosComponents< TComponentType >
 KratosComponents class encapsulates a lookup table for a family of classes in a generic way. More...
 
class  Kratos::IO
 IO provides different implementation of input output procedures which can be used to read and write with different formats and characteristics. More...
 
class  Kratos::GidIO< TGaussPointContainer, TMeshContainer >
 This class defines an interface to the GiDPost library in order to provide GiD compliant I/O functionality. More...
 
class  Kratos::GeometricalObject
 This defines the geometrical object, base definition of the element and condition entities. More...
 
class  Kratos::FNV1a32Hash
 A constexpr version of FNV hash function. (32 bit version) More...
 
class  Kratos::Triangle3D6< TPointType >
 A six node 3D triangular geometry with quadratic shape functions. More...
 
class  Kratos::Triangle2D6< TPointType >
 A six node 2D triangular geometry with quadratic shape functions. More...
 
class  Kratos::Triangle2D15< TPointType >
 A fifteen node 2D triangular geometry with quartic shape functions. More...
 
class  Kratos::Tetrahedra3D4< TPointType >
 A four node tetrahedra geometry with linear shape functions. More...
 
class  Kratos::Quadrilateral3D9< TPointType >
 A nine node 3D quadrilateral geometry with quadratic shape functions. More...
 
class  Kratos::Quadrilateral3D4< TPointType >
 A four node 3D quadrilateral geometry with bi-linear shape functions. More...
 
class  Kratos::Quadrilateral2D8< TPointType >
 A eight node 2D quadrilateral geometry with quadratic shape functions. More...
 
class  Kratos::QuadraturePointSurfaceInVolumeGeometry< TPointType >
 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  Kratos::Pyramid3D5< TPointType >
 A five node pyramid geometry with linear shape functions. More...
 
class  Kratos::Prism3D6< TPointType >
 A six node prism geometry with linear shape functions. More...
 
class  Kratos::OrientedBoundingBox< TDim >
 This class defines the Oriented bounding box class. More...
 
class  NurbsVolumeShapeFunctions
 Provides the shape functions and evaluation methods for trivariant BSpline volumes. More...
 
class  Kratos::Line3D2< TPointType >
 An two node 3D line geometry with linear shape functions. More...
 
class  Kratos::Line2D4< TPointType >
 An three node 2D line geometry with cubic shape functions. More...
 
class  Kratos::Line2D2< TPointType >
 An two node 2D line geometry with linear shape functions. More...
 
class  Kratos::Hexahedra3D27< TPointType >
 A twenty-seven node hexahedra geometry with second order shape functions. More...
 
class  Kratos::CouplingGeometry< TPointType >
 The CouplingGeometry connects two or more geometries of different types and entities. More...
 
class  Kratos::BrepCurveOnSurface< TContainerPointType, TContainerPointEmbeddedType >
 The BrepCurveOnSurface acts as topology for curves on surfaces. More...
 
class  Kratos::StandardPreconditionerFactory< TSparseSpace, TLocalSpace, TPreconditionerType >
 Here we add the functions needed for the registration of preconditioners. More...
 
class  Kratos::PreconditionerFactory< TSparseSpace, TLocalSpace >
 Here we add the functions needed for the registration of preconditioners. More...
 
class  Kratos::Factory< TClass >
 Here we add the functions needed for the registration of class. More...
 
class  Kratos::MeshElement
 This is pure geometric element. The only purpose for this definition is to create dummy elements. More...
 
class  Kratos::Controller
 The base class for all Controllers in Kratos. More...
 
class  Kratos::Variable< TDataType >
 Variable class contains all information needed to store and retrive data from a data container. More...
 
class  Kratos::DataValueContainer
 Container for storing data values associated with variables. More...
 
class  Kratos::LinearMasterSlaveConstraint
 This class allows to add a master-slave constraint which is of the form SlaveDofVector = T * MasterDofVector + ConstantVector. More...
 
class  Kratos::TrilinosDofUpdater< TSparseSpace >
 Utility class to update the values of degree of freedom (Dof) variables after solving the system. More...
 
class  Kratos::RelaxedDofUpdater< TSparseSpace >
 Utility class to update the values of degree of freedom (Dof) variables after solving the system. More...
 
class  Kratos::SubModelPartEntitiesBooleanOperationUtility< TEntityType, TContainerType >
 Wrapper of boolean operations: union, intersection and difference. More...
 
class  Kratos::OpenMPUtils
 Implements basic tasks for OpenMP parallelism and suitable scalar alternatives. More...
 
class  Kratos::LockObject
 This class defines and stores a lock and gives an interface to it. More...
 
class  Kratos::PrimeNumbers
 Gives a prime number before or after given number. More...
 
class  Kratos::RegistryAuxiliaries
 Kratos registry auxiliaries This static class collect all the auxiliary functions to be used to register c++ items. More...
 
class  Kratos::Table< TArgumentType, TResultType, TResultsColumns >
 This class represents the value of its variable depending to other variable. More...
 
class  Kratos::TableAccessor
 This class defines the way a certain property is accessed according to a table. More...
 
class  Kratos::TableStream
 This is a fancy table to stream data in a fancy way. More...
 
class  Kratos::FileLoggerOutput
 FileLoggerOutput is a class for all file logger outputs. More...
 
class  Kratos::LoggerOutput
 LoggerOutput is the base class for all logger outputs. More...
 
class  Kratos::TetrahedraBall
 Stores a ball of tetrahedra sourronding a node of mesh. More...
 
class  Kratos::DistributedModelPartInitializer
 Initialize a distributed ModelPart from a serial one. More...
 
class  Kratos::MPINormalCalculationUtils
 Some tools to calculate face and nodal normals on an MPI partitioned environment. More...
 
class  Kratos::TetrahedraEdgeShell
 This class defines an edge shell for a mesh of tetrahedra. More...
 
class  Kratos::LoggerTableOutput
 LoggerTableOutput takes columns names and only prints the messages with lable given with column name. More...
 
class  Kratos::LoggerMessage
 LoggerMessage class holdes message and the properties of the message. More...
 
class  Kratos::ThreadFixedSizeMemoryPool
 ThreadFixedSizeMemoryPool holds chunks belong to a certain thread and operate over them. More...
 
class  Kratos::endl
 
class  Kratos::Table< double, double >
 
class  Kratos::RegistryItem
 The registry item to be stored by Registry class. It is the base class for some more specific ones. More...
 
class  Kratos::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  Kratos::MemoryPool
 MemoryPool is the smallest building block of Kratos memory management. More...
 
class  Kratos::IndexDatabase
 Base class to derive common methods. More...
 
class  Kratos::IndexSet
 Custom unordered set container to be used by the mapper. More...
 
class  Kratos::IndexMap
 Custom unordered map container to be used by the mapper. More...
 
class  Kratos::MasterSlaveConstraint
 A class that implements the interface for different master-slave constraints to be applied on a system. More...
 
class  Kratos::Mesh< TNodeType, TPropertiesType, TElementType, TConditionType >
 Mesh is the second level of abstraction in the data structure which hold Nodes, Elements and Conditions and their Properties. More...
 
class  Kratos::ModelPart
 This class aims to manage meshes for multi-physics simulations. More...
 
class  Kratos::MortarKinematicVariables< TNumNodes, TNumNodesMaster >
 MortarKinematicVariables. More...
 
class  Kratos::MortarKinematicVariablesWithDerivatives< TDim, TNumNodes, TNumNodesMaster >
 MortarKinematicVariablesWithDerivatives. More...
 
class  Kratos::DerivativeData< TDim, TNumNodes, TNumNodesMaster >
 This data will be used to compute the derivatives. More...
 
class  Kratos::DerivativeDataFrictional< TDim, TNumNodes, TNumNodesMaster >
 This class is a derived class of DerivativeData. More...
 
class  Kratos::MortarOperator< TNumNodes, TNumNodesMaster >
 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  Kratos::MortarOperatorWithDerivatives< TDim, TNumNodes, TFrictional, TNumNodesMaster >
 This class derives from the MortarOperator class and it includes the derived operators. More...
 
class  Kratos::DualLagrangeMultiplierOperators< TNumNodes, TNumNodesMaster >
 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  Kratos::DualLagrangeMultiplierOperatorsWithDerivatives< TDim, TNumNodes, TFrictional, TNumNodesMaster >
 This is the definition dual lagrange multiplier operators including the derivatives. More...
 
class  Kratos::PointBelong< TNumNodes, TNumNodesMaster >
 Custom Point container to be used by the mapper. More...
 
class  Kratos::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  Kratos::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  Kratos::AMGCLSolver< TSparseSpaceType, TDenseSpaceType, TReordererType >
 This is a multigrid solver based on the AMGCL library. More...
 
class  Kratos::MonotonicityPreservingSolver< TSparseSpaceType, TDenseSpaceType, TReordererType >
 
class  Kratos::PowerIterationEigenvalueSolver< TSparseSpaceType, TDenseSpaceType, TLinearSolverType, TPreconditionerType, TReordererType >
 This class uses the inverted power iteration method to obtain the lowest eigenvalue of a system. More...
 
class  Kratos::PowerIterationHighestEigenvalueSolver< TSparseSpaceType, TDenseSpaceType, TLinearSolverType, TPreconditionerType, TReordererType >
 This class uses the inverted power iteration method to obtain the lowest eigenvalue of a system. More...
 
class  Kratos::RayleighQuotientIterationEigenvalueSolver< TSparseSpaceType, TDenseSpaceType, TLinearSolverType, TPreconditionerType, TReordererType >
 This is a eigen solver based on the Rayleigh quotient iteration algorithm. More...
 
class  Kratos::ScalingSolver< TSparseSpaceType, TDenseSpaceType, TReordererType >
 This solvers rescales in order to improve the conditioning of the system. More...
 
class  Kratos::CombineModelPartModeler
 This modeler combines several model parts into a new one. All input model parts should share the same root model part. More...
 
class  Kratos::CreateEntitiesFromGeometriesModeler
 Modeler to create element/condition entities from geometries. More...
 
class  Kratos::SerialModelPartCombinatorModeler
 This modeler combines several model parts in serial, reading its respective *.mdpa files (maybe others in the future) More...
 
class  Kratos::Operation
 The base class for all operations in Kratos. More...
 
class  Kratos::AssignScalarFieldToEntitiesProcess< TEntity >
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  Kratos::AssignScalarInputToEntitiesProcess< TEntity, THistorical >
 This function assigns a value from an input to a variable belonging to all of the entities in a given mesh. More...
 
class  Kratos::AssignScalarVariableToEntitiesProcess< TEntity >
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  Kratos::CalculateDistanceToPathProcess< THistorical >
 Computes DISTANCE from a path model part to a given model part. More...
 
class  Kratos::CalculateNodalAreaProcess< THistorical >
 Computes NODAL_AREA. More...
 
class  Kratos::CheckSameModelPartUsingSkinDistanceProcess< TDim >
 Checks that the model part is the same using the skin distance. More...
 
class  Kratos::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...
 
class  Kratos::ComputeNodalGradientProcess< THistorical >
 Compute Nodal Gradient process. More...
 
class  Kratos::ComputeNodalNormalDivergenceProcess< THistorical >
 Compute Nodal Normal Divergence process. More...
 
class  Kratos::EntitiesEraseProcess< TEntity >
 This process removes the entities from a model part with the flag TO_ERASE. More...
 
class  Kratos::FastTransferBetweenModelPartsProcess
 The base class for assigning a value to scalar variables or array_1d components processes in Kratos. More...
 
class  Kratos::FindIntersectedGeometricalObjectsWithOBBProcess
 This class takes two modelparts and marks the intersected ones with SELECTED flag. Does the check considering an OBB for the intersection. More...
 
class  Kratos::FindNodalHProcess< THistorical >
 Computes NODAL_H. More...
 
class  Kratos::FindNodalNeighboursProcess
 This method allows to look for neighbours in a triangular or tetrahedral mesh. More...
 
class  Kratos::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  Kratos::IntegrationValuesExtrapolationToNodesProcess
 This process extrapolates vales from the integration points to the nodes. More...
 
class  Kratos::Process
 The base class for all processes in Kratos. More...
 
class  Kratos::ReplaceElementsAndConditionsProcess
 This methods replaces elements and conditions in a model part by a given name. More...
 
class  Kratos::SimpleMortarMapperProcess< TDim, TNumNodes, TVarType, TNumNodesMaster >
 This is basic mapper of values between domains using mortar formulation. More...
 
class  Kratos::SimpleMortarMapperProcessWrapper
 This class wraps automatically the different types mof mappers. More...
 
class  Kratos::SkinDetectionProcess< TDim >
 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  Kratos::SplitInternalInterfacesProcess
 Computes NODAL_AREA. More...
 
class  Kratos::TetrahedralMeshOrientationCheck
 Check a triangular or tetrahedral mesh to ensure that local connectivities follow the expected convention. More...
 
class  Kratos::BuilderAndSolver< TSparseSpace, TDenseSpace, TLinearSolver >
 Current class provides an implementation for the base builder and solving operations. More...
 
class  Kratos::ExplicitBuilder< TSparseSpace, TDenseSpace >
 Current class provides an implementation for the base explicit builder and solving operations. More...
 
class  Kratos::ResidualBasedBlockBuilderAndSolver< TSparseSpace, TDenseSpace, TLinearSolver >
 Current class provides an implementation for standard builder and solving operations. More...
 
class  Kratos::ResidualBasedBlockBuilderAndSolverWithLagrangeMultiplier< TSparseSpace, TDenseSpace, TLinearSolver >
 Current class provides an implementation for standard builder and solving operations. More...
 
class  Kratos::ResidualBasedEliminationBuilderAndSolver< TSparseSpace, TDenseSpace, TLinearSolver >
 Current class provides an implementation for standard elimination builder and solving operations. More...
 
class  Kratos::ResidualBasedEliminationBuilderAndSolverWithConstraints< TSparseSpace, TDenseSpace, TLinearSolver >
 Current class provides an implementation for standard builder and solving operations. More...
 
class  Kratos::And_Criteria< TSparseSpace, TDenseSpace >
 This convergence criteria checks simultaneously two convergence criteria (both must be satisfied) More...
 
class  Kratos::ConvergenceCriteria< TSparseSpace, TDenseSpace >
 This is the base class to define the different convergence criterion considered. More...
 
class  Kratos::DisplacementCriteria< TSparseSpace, TDenseSpace >
 This is a convergence criteria that considers the increment on the solution as criteria. More...
 
class  Kratos::Or_Criteria< TSparseSpace, TDenseSpace >
 This convergence criteria checks simultaneously two convergence criteria (one of them must be satisfied) More...
 
class  Kratos::ResidualCriteria< TSparseSpace, TDenseSpace >
 This is a convergence criteria that considers the residual as criteria. More...
 
class  Kratos::ResidualBasedBDFCustomScheme< TSparseSpace, TDenseSpace >
 BDF integration scheme (for dynamic problems) More...
 
class  Kratos::ResidualBasedBDFDisplacementScheme< TSparseSpace, TDenseSpace >
 BDF integration scheme (displacement based) More...
 
class  Kratos::ResidualBasedBDFScheme< TSparseSpace, TDenseSpace >
 BDF integration scheme (for dynamic problems) More...
 
class  Kratos::ResidualBasedBossakDisplacementScheme< TSparseSpace, TDenseSpace >
 Bossak integration scheme (for linear and nonlinear dynamic problems) for displacements. More...
 
class  Kratos::ResidualBasedImplicitTimeScheme< TSparseSpace, TDenseSpace >
 This is the base class for the implicit time schemes. More...
 
class  Kratos::ResidualBasedNewmarkDisplacementScheme< TSparseSpace, TDenseSpace >
 Bossak integration scheme (for dynamic problems) for displacements. More...
 
class  Kratos::ResidualBasedPseudoStaticDisplacementScheme< TSparseSpace, TDenseSpace >
 This is a pseudo-static scheme. More...
 
class  Kratos::ResidualBasedIncrementalUpdateStaticScheme< TSparseSpace, TDenseSpace >
 This class provides the implementation of a static scheme. More...
 
class  Kratos::Scheme< TSparseSpace, TDenseSpace >
 This class provides the implementation of the basic tasks that are needed by the solution strategy. More...
 
class  Kratos::ArcLengthStrategy< TSparseSpace, TDenseSpace, TLinearSolver >
 This is the base ArcLengthStrategy. More...
 
class  Kratos::ResidualBasedLinearStrategy< TSparseSpace, TDenseSpace, TLinearSolver >
 This is a very simple strategy to solve linearly the problem. More...
 
class  Kratos::ResidualBasedNewtonRaphsonStrategy< TSparseSpace, TDenseSpace, TLinearSolver >
 This is the base Newton Raphson strategy. More...
 
class  Kratos::UblasSpace< TDataType, TMatrixType, TVectorType >
 A class template for handling data types, matrices, and vectors in a Ublas space. More...
 
class  Kratos::BinsDynamic< TDimension, TPointType, TContainerType, TPointerType, TIteratorType, TDistanceIteratorType, TDistanceFunction >
 A dynamic binning data structure template for organizing and querying points in multi-dimensional space. More...
 
class  Kratos::PointObject< TObject >
 Custom Point container to be used by the search. More...
 
class  Kratos::SpatialSearch
 This class is used to search for elements, conditions and nodes in a given model part. More...
 
class  Kratos::SpecializedSpatialSearch< TSearchBackend >
 This class is used to search for elements, conditions and nodes in a given model part. More...
 
class  Kratos::SpecializedSpatialSearchFactory
 Factory for the specialized spatial search. More...
 
class  Kratos::Tree< TPartitionType >
 A generic tree data structure for spatial partitioning. More...
 
class  Kratos::AdjointExtensions
 Interface extensions for adjoint elements and conditions. More...
 
class  Kratos::ApplyFunctionToNodesUtility
 This function applies a givn function to its nodes calling GenericFunctionUtility. More...
 
class  Kratos::AssignMasterSlaveConstraintsToNeighboursUtility
 Assing Master-Slave Constraints to Neighbouring Nodes. More...
 
class  Kratos::AssignUniqueModelPartCollectionTagUtility
 Get the collection of submodelparts each node, condition and element belongs to. More...
 
class  Kratos::AuxiliarModelPartUtilities
 This utility includes auxiliar methods not included in the model part to avoid increase more than necessary the API. More...
 
class  Kratos::BinBasedFastPointLocator< TDim, TConfigureType >
 This class is designed to allow the fast location of MANY points on the top of a 3D mesh. More...
 
class  Kratos::BinBasedFastPointLocatorConditions< TDim >
 This class is designed to allow the fast location of MANY points on the top of a 3D mesh. (for conditions) More...
 
class  Kratos::ConditionNumberUtility
 Utility to compute the condition number. More...
 
class  Kratos::ExactMortarIntegrationUtility< TDim, TNumNodes, TBelong, TNumNodesMaster >
 This utility calculates the exact integration necessary for the Mortar Conditions. More...
 
class  Kratos::BasicGenericFunctionUtility
 This function allows to call a function method of type f(x, y, z, t) implemented in python style. More...
 
class  Kratos::GenericFunctionUtility
 GenericFunctionUtility. More...
 
class  Kratos::FunctionParser
 GenericFunctionUtility. More...
 
class  Kratos::GeometricalProjectionUtilities
 This is a class that provides auxiliar utilities for projections. More...
 
class  Kratos::GeometryTesterUtility
 This utility tests the geometries. More...
 
class  Kratos::GeometryUtils
 This function provides basic routines for working with simplicial meshes. More...
 
class  Kratos::IndirectScalar< T, S >
 Wrapper for a function which behaves like an arithmetic type. More...
 
class  Kratos::IntegrationUtilities
 Utilities to integrate in different cases. More...
 
class  Kratos::IntersectionUtilities
 Utilities to compute intersections between different geometries. More...
 
class  Kratos::MathUtils< TDataType >
 Various mathematical utilitiy functions. More...
 
class  Kratos::ModelPartCombinationUtilities
 This utility helps combine different ModelParts into one single ModelPart, with the corresponding sub ModelParts. More...
 
class  Kratos::ParticlesUtilities
 Collection of utilities to compute statistic of particles. More...
 
class  Kratos::PlaneApproximationUtility< TDim >
 Utility to compute an approximation plane for a set of points. More...
 
class  Kratos::PythonGenericFunctionUtility
 This function allows to call a function method of type f(x, y, z, t) implemented in python. More...
 
class  Kratos::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  Kratos::RandomInitializeUtility< TDataType >
 Utility to initialize a random vector. More...
 
class  Kratos::ReadAndSetAccessorsUtilities
 
class  Kratos::ReadMaterialsUtility
 Process to read constitutive law and material properties from a json file. More...
 
class  Kratos::EntityDatabase
 This class stores the results of a entity. More...
 
class  Kratos::VariableDatabase
 This class stores the results of a variable. More...
 
class  Kratos::ResultDatabase
 This class stores the results of a simulation for a later comparison. More...
 
class  Kratos::SearchUtilities
 MPI utilities for searching geometrical objects. More...
 
class  Kratos::SparseMatrixMultiplicationUtility
 An utility to multiply sparse matrix in Ublas. More...
 
class  Kratos::SpatialContainersConfigure< TDimension, TEntity >
 Thhis class is a container for spatial search. More...
 
class  Kratos::SpecificationsUtilities
 This namespace includes several utilities necessaries for evaluate specifications. More...
 
class  Kratos::SVDUtils< TDataType >
 Various mathematical utilities to compute SVD and the condition number of a matrix. More...
 
class  Kratos::Timer
 This utility can be used to compute the time employed on computations. More...
 
class  Kratos::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  Kratos::Line3DN< TPointType >
 A arbitrary node 3D line geometry with quadratic shape functions. More...
 
class  Kratos::FemDemResidualCriteria< TSparseSpace, TDenseSpace >
 This is a convergence criteria that employes the residual as criteria. More...
 
class  Kratos::HexahedraNewtonRaphsonStrategy< TSparseSpace, TDenseSpace, TLinearSolver >
 This is the base Newton Raphson strategy. More...
 
class  Kratos::NodalResidualBasedEliminationBuilderAndSolver< TSparseSpace, TDenseSpace, TLinearSolver >
 Current class provides an implementation for standard builder and solving operations. More...
 
class  Kratos::NodalResidualBasedEliminationBuilderAndSolverContinuity< TSparseSpace, TDenseSpace, TLinearSolver >
 Current class provides an implementation for standard builder and solving operations. More...
 
class  Kratos::NodalResidualBasedEliminationBuilderAndSolverContinuityForFSI< TSparseSpace, TDenseSpace, TLinearSolver >
 Current class provides an implementation for standard builder and solving operations. More...
 
class  Kratos::NodalResidualBasedEliminationBuilderAndSolverForFSI< TSparseSpace, TDenseSpace, TLinearSolver >
 Current class provides an implementation for standard builder and solving operations. More...
 
class  Kratos::RelaxedResidualBasedNewtonRaphsonStrategy< TSparseSpace, TDenseSpace, TLinearSolver >
 This is the base Newton Raphson strategy. More...
 
class  Kratos::TrilinosLinearSolverFactory< TSparseSpace, TLocalSpace, TLinearSolverType >
 Here we add the functions needed for the registration of linear solvers. More...
 
class  Kratos::TrilinosMonotonicityPreservingSolver< TSparseSpaceType, TDenseSpaceType, TReordererType >
 

Functions

std::size_t Kratos::GlobalPointerHasher< TDataType >::operator() (const GlobalPointer< TDataType > &pGp) const
 The () operator for hashing a GlobalPointer. More...
 
bool Kratos::GlobalPointerComparor< TDataType >::operator() (const GlobalPointer< TDataType > &pGp1, const GlobalPointer< TDataType > &pGp2) const
 The () operator. More...
 
bool Kratos::GlobalPointerCompare< TDataType >::operator() (const GlobalPointer< TDataType > &pGp1, const GlobalPointer< TDataType > &pGp2) const
 The () operator. More...
 
bool Kratos::KeyComparorRange< TClassType >::operator() (const TClassType &first, const TClassType &second) const
 This is the () operator. More...
 
HashType Kratos::KeyHasherRange< TClassType >::operator() (const TClassType &rRange) const
 This is the () operator. More...
 
HashType Kratos::VariableHasher::operator() (const VariableData &rVariable) const
 This is the () operator. More...
 
bool Kratos::VariableComparator::operator() (const VariableData &rFirst, const VariableData &rSecond) const
 This is the () operator. More...
 
HashType Kratos::pVariableHasher::operator() (const VariableData *pVariable) const
 This is the () operator. More...
 
bool Kratos::pVariableComparator::operator() (const VariableData *pFirst, const VariableData *pSecond) const
 This is the () operator. More...
 
HashType Kratos::IndexedObjectHasher< TIndexedObject >::operator() (const TIndexedObject &rIndexedObject) const
 This is the () operator. More...
 
bool Kratos::IndexedObjectComparator< TIndexedObject >::operator() (const TIndexedObject &rFirst, const TIndexedObject &rSecond) const
 This is the () operator. More...
 
HashType Kratos::IndexedObjectPointerHasher< TpIndexedObject >::operator() (const TpIndexedObject pIndexedObject) const
 This is the () operator. More...
 
bool Kratos::IndexedObjectPointerComparator< TpIndexedObject >::operator() (const TpIndexedObject pFirst, const TpIndexedObject pSecond) const
 This is the () operator. More...
 
HashType Kratos::SharedPointerHasher< TSharedPointer >::operator() (const TSharedPointer &pPointer) const
 This is the () operator. More...
 
bool Kratos::SharedPointerComparator< TSharedPointer >::operator() (const TSharedPointer &first, const TSharedPointer &second) const
 This is the () operator. More...
 
HashType Kratos::VectorIndexHasher< TVectorIndex >::operator() (const TVectorIndex &k) const
 This is the () operator. More...
 
bool Kratos::VectorIndexComparor< TVectorIndex >::operator() (const TVectorIndex &lhs, const TVectorIndex &rhs) const
 This is the () operator. More...
 
HashType Kratos::DofPointerHasher::operator() (const Dof< double >::Pointer &pDoF) const
 The () operator. More...
 
bool Kratos::DofPointerComparor::operator() (const Dof< double >::Pointer &pDoF1, const Dof< double >::Pointer &pDoF2) const
 The () operator. More...
 
HashType Kratos::PairHasher< TType1, TType2 >::operator() (const std::pair< TType1, TType2 > &rPair) const
 The () operator. More...
 
bool Kratos::PairComparor< TType1, TType2 >::operator() (const std::pair< TType1, TType2 > &rPair1, const std::pair< TType1, TType2 > &rPair2) const
 The () operator. More...
 
size_t std::hash< std::pair< T1, T2 > >::operator() (const std::pair< T1, T2 > &p) const
 Calculates the hash value of a given pair of values in a way that combines the hash values of the individual elements. More...
 

Type Definitions

using Kratos::GlobalPointer< TDataType >::element_type = TDataType
 Definition of element type. More...
 

Type Definitions

using Kratos::IndexType = std::size_t
 The definition of the index type. More...
 
using Kratos::HashType = std::size_t
 The definition of the hash type. More...
 

Type Definitions

typedef TSparseSpace::VectorType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::VectorType
 
typedef TSparseSpace::MatrixType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::MatrixType
 
typedef TSparseSpace::VectorPointerType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::VectorPointerType
 
typedef TSparseSpace::MatrixPointerType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::MatrixPointerType
 
typedef TDenseSpace::VectorType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::DenseVectorType
 
typedef TDenseSpace::MatrixType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::DenseMatrixType
 
typedef TDenseSpace::MatrixPointerType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::DenseMatrixPointerType
 
typedef TDenseSpace::VectorPointerType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::DenseVectorPointerType
 
 Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::KRATOS_CLASS_POINTER_DEFINITION (ConvergenceAccelerator)
 

Protected member Variables

int Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::mEchoLevel
 

Serialization

class Kratos::GlobalPointer< TDataType >::Serializer
 Friend class Serializer for handling serialization. More...
 

Serialization

class Kratos::TableStream::Serializer
 

Input and output

template<class TDataType >
std::istream & Kratos::operator>> (std::istream &rIStream, DistributedCsrMatrix< TDataType > &rThis)
 input stream function More...
 
template<class TDataType >
std::ostream & Kratos::operator<< (std::ostream &rOStream, const DistributedCsrMatrix< TDataType > &rThis)
 output stream function More...
 
template<class TDataType , class TIndexType >
std::istream & Kratos::operator>> (std::istream &rIStream, DistributedNumbering< TIndexType > &rThis)
 input stream function More...
 
template<class TDataType , class TIndexType >
std::ostream & Kratos::operator<< (std::ostream &rOStream, const DistributedNumbering< TIndexType > &rThis)
 output stream function More...
 
template<class TIndexType >
std::istream & Kratos::operator>> (std::istream &rIStream, DistributedVectorExporter< TIndexType > &rThis)
 input stream function More...
 
template<class TIndexType >
std::ostream & Kratos::operator<< (std::ostream &rOStream, const DistributedVectorExporter< TIndexType > &rThis)
 output stream function More...
 
template<unsigned int TDim>
std::istream & Kratos::operator>> (std::istream &rIStream, EdgeBasedDataStructure< TDim > &rThis)
 input stream function More...
 
template<unsigned int TDim>
std::ostream & Kratos::operator<< (std::ostream &rOStream, const EdgeBasedDataStructure< TDim > &rThis)
 output stream function More...
 
template<class TDataType >
std::istream & Kratos::operator>> (std::istream &rIStream, GlobalPointersVector< TDataType > &rThis)
 input stream function More...
 
template<class TDataType >
std::ostream & Kratos::operator<< (std::ostream &rOStream, const GlobalPointersVector< TDataType > &rThis)
 output stream function More...
 
std::istream & Kratos::operator>> (std::istream &rIStream, Model &rThis)
 input stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const Model &rThis)
 output stream function More...
 
std::istream & Kratos::operator>> (std::istream &rIStream, NodalData &rThis)
 input stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const NodalData &rThis)
 output stream function More...
 
template<class TIndexType = std::size_t>
std::istream & Kratos::operator>> (std::istream &rIStream, SparseContiguousRowGraph< TIndexType > &rThis)
 input stream function More...
 
template<class TIndexType = std::size_t>
std::ostream & Kratos::operator<< (std::ostream &rOStream, const SparseContiguousRowGraph< TIndexType > &rThis)
 output stream function More...
 
template<std::size_t TDim>
std::istream & Kratos::operator>> (std::istream &rIStream, EdgeBasedGradientRecoveryElement< TDim > &rThis)
 input stream function More...
 
template<std::size_t TDim>
std::ostream & Kratos::operator<< (std::ostream &rOStream, const EdgeBasedGradientRecoveryElement< TDim > &rThis)
 output stream function More...
 
template<class TVarType >
std::istream & Kratos::operator>> (std::istream &rIStream, EmbeddedNodalVariableCalculationElementSimplex< TVarType > &rThis)
 input stream function More...
 
template<class TVarType >
std::ostream & Kratos::operator<< (std::ostream &rOStream, const EmbeddedNodalVariableCalculationElementSimplex< TVarType > &rThis)
 output stream function More...
 
template<typename TPointType >
std::istream & Kratos::operator>> (std::istream &rIStream, BoundingBox< TPointType > &rThis)
 input stream function More...
 
template<typename TPointType >
std::ostream & Kratos::operator<< (std::ostream &rOStream, const BoundingBox< TPointType > &rThis)
 output stream function More...
 
std::istream & Kratos::operator>> (std::istream &rIStream, Exception &rThis)
 input stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const Exception &rThis)
 output stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const FixedSizeMemoryPool &rThis)
 output stream function More...
 
std::istream & Kratos::operator>> (std::istream &rIStream, Parameters &rThis)
 input stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const Parameters &rThis)
 output stream function More...
 
std::istream & Kratos::operator>> (std::istream &rIStream, Registry &rThis)
 input stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const Registry &rThis)
 output stream function More...
 
std::istream & Kratos::operator>> (std::istream &rIStream, RegistryItem &rThis)
 input stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const RegistryItem &rThis)
 output stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const ThreadFixedSizeMemoryPool &rThis)
 output stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const LoggerMessage &rThis)
 output stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const LoggerOutput &rThis)
 output stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const LoggerTableOutput &rThis)
 output stream function More...
 
std::istream & Kratos::operator>> (std::istream &rIStream, TetrahedraBall &rThis)
 input stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const TetrahedraBall &rThis)
 output stream function More...
 
std::istream & Kratos::operator>> (std::istream &rIStream, TetrahedraEdgeShell &rThis)
 input stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const TetrahedraEdgeShell &rThis)
 output stream function More...
 
std::istream & Kratos::operator>> (std::istream &rIStream, MPINormalCalculationUtils &rThis)
 input stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const MPINormalCalculationUtils &rThis)
 output stream function More...
 
std::istream & Kratos::operator>> (std::istream &rIStream, MeshCoarseningProcess &rThis)
 input stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const MeshCoarseningProcess &rThis)
 output stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const OutputProcess &rThis)
 output stream function More...
 
std::istream & Kratos::operator>> (std::istream &rIStream, ReorderAndOptimizeModelPartProcess &rThis)
 input stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const ReorderAndOptimizeModelPartProcess &rThis)
 output stream function More...
 
std::istream & Kratos::operator>> (std::istream &rIStream, StructuredMeshGeneratorProcess &rThis)
 input stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const StructuredMeshGeneratorProcess &rThis)
 output stream function More...
 
template<SizeType TDim>
std::istream & Kratos::operator>> (std::istream &rIStream, SubModelPartSkinDetectionProcess< TDim > &rThis)
 input stream function More...
 
template<SizeType TDim>
std::ostream & Kratos::operator<< (std::ostream &rOStream, const SubModelPartSkinDetectionProcess< TDim > &rThis)
 output stream function More...
 
std::istream & Kratos::operator>> (std::istream &rIStream, TestSkippedException &rThis)
 input stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const TestSkippedException &rThis)
 output stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const BruteForcePointLocator &rThis)
 output stream function More...
 
template<class TLocalMatrixType , class TLocalVectorType , class TValueType >
std::istream & Kratos::operator>> (std::istream &rIStream, CoordinateTransformationUtils< TLocalMatrixType, TLocalVectorType, TValueType > &rThis)
 input stream function More...
 
template<class TLocalMatrixType , class TLocalVectorType , class TValueType >
std::ostream & Kratos::operator<< (std::ostream &rOStream, const CoordinateTransformationUtils< TLocalMatrixType, TLocalVectorType, TValueType > &rThis)
 output stream function More...
 
template<class TSparseSpace >
std::istream & Kratos::operator>> (std::istream &rIStream, DofUpdater< TSparseSpace > &rThis)
 input stream function More...
 
template<class TSparseSpace >
std::ostream & Kratos::operator<< (std::ostream &rOStream, const DofUpdater< TSparseSpace > &rThis)
 output stream function More...
 
std::istream & Kratos::operator>> (std::istream &rIStream, GlobalPointerUtilities &rThis)
 input stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const GlobalPointerUtilities &rThis)
 output stream function More...
 
std::istream & Kratos::operator>> (std::istream &rIStream, MergeVariableListsUtility &rThis)
 input stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const MergeVariableListsUtility &rThis)
 output stream function More...
 
std::istream & Kratos::operator>> (std::istream &rIStream, RVEPeriodicityUtility &rThis)
 input stream function More...
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const RVEPeriodicityUtility &rThis)
 output stream function More...
 
template<class TSparseSpace >
std::istream & Kratos::operator>> (std::istream &rIStream, RelaxedDofUpdater< TSparseSpace > &rThis)
 input stream function More...
 
template<class TSparseSpace >
std::ostream & Kratos::operator<< (std::ostream &rOStream, const RelaxedDofUpdater< TSparseSpace > &rThis)
 output stream function More...
 
template<class TSparseSpace >
std::istream & Kratos::operator>> (std::istream &rIStream, TrilinosDofUpdater< TSparseSpace > &rThis)
 input stream function More...
 
template<class TSparseSpace >
std::ostream & Kratos::operator<< (std::ostream &rOStream, const TrilinosDofUpdater< TSparseSpace > &rThis)
 output stream function More...
 

Operators

bool Kratos::operator<< (Chunk const &rFirst, Chunk const &rSedond)
 
std::ostream & Kratos::operator<< (std::ostream &rOStream, const Chunk &rThis)
 output stream function More...
 

Life Cycle

 Kratos::GlobalPointer< TDataType >::GlobalPointer ()
 Default constructor. More...
 
 Kratos::GlobalPointer< TDataType >::GlobalPointer (TDataType Data)=delete
 Constructor by Data. More...
 
 Kratos::GlobalPointer< TDataType >::GlobalPointer (TDataType *DataPointer, int Rank=0)
 Constructor by DataPointer. More...
 
 Kratos::GlobalPointer< TDataType >::GlobalPointer (Kratos::shared_ptr< TDataType > DataPointer, int Rank=0)
 Constructor by Kratos::shared_ptr. More...
 
 Kratos::GlobalPointer< TDataType >::GlobalPointer (Kratos::intrusive_ptr< TDataType > &DataPointer, int Rank=0)
 Constructor by Kratos::intrusive_ptr. More...
 
 Kratos::GlobalPointer< TDataType >::GlobalPointer (Kratos::weak_ptr< TDataType > DataPointer, int Rank=0)
 Constructor by Kratos::weak_ptr. More...
 
 Kratos::GlobalPointer< TDataType >::GlobalPointer (std::unique_ptr< TDataType > DataPointer, int Rank=0)=delete
 Constructor by std::unique_ptr. More...
 
 Kratos::GlobalPointer< TDataType >::GlobalPointer (const GlobalPointer &rOther)
 Copy constructor for GlobalPointer. More...
 
 Kratos::GlobalPointer< TDataType >::GlobalPointer (const GlobalPointer &&rOther)
 Move constructor for GlobalPointer. More...
 
 Kratos::GlobalPointer< TDataType >::~GlobalPointer ()=default
 Destructor. More...
 

Operators

GlobalPointerKratos::GlobalPointer< TDataType >::operator= (const GlobalPointer &rOther)
 Assignment operator for GlobalPointer. More...
 
TDataType & Kratos::GlobalPointer< TDataType >::operator* ()
 Dereference operator for non-const GlobalPointer. More...
 
TDataType const & Kratos::GlobalPointer< TDataType >::operator* () const
 Dereference operator for const GlobalPointer. More...
 
TDataType * Kratos::GlobalPointer< TDataType >::operator-> ()
 Arrow operator for non-const GlobalPointer. More...
 
TDataType const * Kratos::GlobalPointer< TDataType >::operator-> () const
 Arrow operator for const GlobalPointer. More...
 
bool Kratos::GlobalPointer< TDataType >::operator== (const GlobalPointer &rOther)
 Overloads the '==' operator to compare two GlobalPointer objects of the same template type. Returns true if the underlying pointers are equal. More...
 

Access

TDataType * Kratos::GlobalPointer< TDataType >::get ()
 Get a non-const pointer to the data. More...
 
TDataType const * Kratos::GlobalPointer< TDataType >::get () const
 Get a const pointer to the data. More...
 
int Kratos::GlobalPointer< TDataType >::GetRank () const
 Returns the rank of the global pointer. More...
 
void Kratos::GlobalPointer< TDataType >::SetRank (const int Rank)
 Sets the rank of the global pointer. More...
 

Inquiry

void Kratos::GlobalPointer< TDataType >::save (char *buffer) const
 Fills buffer with the GlobalPoiter data. More...
 
void Kratos::GlobalPointer< TDataType >::load (char *buffer)
 Restores the GlobalPoiter with the data from the buffer. More...
 

Input and output

std::string Kratos::GlobalPointer< TDataType >::Info () const
 Turn back information as a string. More...
 
void Kratos::GlobalPointer< TDataType >::PrintInfo (std::ostream &rOStream) const
 Print information about this object. More...
 
void Kratos::GlobalPointer< TDataType >::PrintData (std::ostream &rOStream) const
 Print object's data. More...
 

Kratos Classes

template<class TDataType >
std::istream & Kratos::operator>> (std::istream &rIStream, GlobalPointer< TDataType > &rThis)
 input stream function More...
 
template<class TDataType >
std::ostream & Kratos::operator<< (std::ostream &rOStream, const GlobalPointer< TDataType > &rThis)
 output stream function More...
 

Functions

template<class TClassType >
void Kratos::HashCombine (HashType &Seed, const TClassType &Value)
 This method creates an "unique" hash for the input value. More...
 
template<class TClassType >
HashType Kratos::HashRange (TClassType First, TClassType Last)
 This method combines hash until it reaches the last class in order to obtain a corresponding seed. More...
 

Type Definitions

 Kratos::TableStream::KRATOS_CLASS_POINTER_DEFINITION (TableStream)
 Pointer definition of TableStream. More...
 

Life Cycle

 Kratos::TableStream::TableStream (std::ostream *Output, const std::string &Separator="|", const bool UseBoldFont=true)
 Default constructor. More...
 
virtual Kratos::TableStream::~TableStream ()=default
 Destructor. More...
 

Operators

template<typename TClass >
TableStreamKratos::TableStream::operator<< (TClass Input)
 This is the operator << for any kind of input. More...
 
TableStreamKratos::TableStream::operator<< (float Input)
 This is the operator << just for floats. More...
 
TableStreamKratos::TableStream::operator<< (double Input)
 This is the operator << just for doubles. More...
 

Operations

unsigned int Kratos::TableStream::GetNumColumns () const
 It returns the number of columns. More...
 
unsigned int Kratos::TableStream::GetTableWidth () const
 It returns the table width. More...
 
void Kratos::TableStream::SetSeparator (const std::string &Separator)
 Set the separator used for the table. More...
 
void Kratos::TableStream::SetBold (const bool &UseBoldFont)
 Set if the bold fonts are used for the table. More...
 
void Kratos::TableStream::SetFlushLeft ()
 Set the flush orientation to the left. More...
 
void Kratos::TableStream::SetFlushRight ()
 Set the flush orientation to the right. More...
 
void Kratos::TableStream::AddColumn (const std::string &HeaderName, const int ColumnWidth)
 Add a column to our table. More...
 
void Kratos::TableStream::PrintHeader ()
 This function prints the header of the stream. More...
 
void Kratos::TableStream::PrintFooter ()
 This function prints the footer of the stream. More...
 

Life Cycle

 Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::ConvergenceAccelerator ()=default
 
 Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::ConvergenceAccelerator (Parameters ThisParameters)
 
 Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::ConvergenceAccelerator (const ConvergenceAccelerator &Other)=delete
 
virtual Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::~ConvergenceAccelerator ()=default
 

Operations

virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::Initialize ()
 Initialize the convergence accelerator Operations that are required to be done once before the resolution of the problem. More...
 
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::InitializeSolutionStep ()
 Operations before solving the solution step Performs all the required operations that should be done (for each step) before solving the solution step. More...
 
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::InitializeNonLinearIteration ()
 Operations before each non-linear iteration Performs all the required operations that should be done before each non-linear iteration. More...
 
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::UpdateSolution (const VectorType &rResidualVector, VectorType &rIterationGuess)
 Corrects the given iteration guess Computes the correction of the iteration guess according to the provided residual vector Note that the correction is performed over the given iteration guess, so the return value is already modified. More...
 
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::FinalizeNonLinearIteration ()
 Operations after each non-linear iteration Performs all the required operations that should be done at the end of each non-linear iteration. More...
 
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::FinalizeSolutionStep ()
 Operations after solving the solution step Performs all the required operations that should be done (for each step) after solving the solution step. More...
 
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::Finalize ()
 Finalize the convergence accelerator Perform all the operations required after the resolution of the problem. More...
 
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::Clear ()
 Clear the internal storage Clears all the internal data (e.g. previous observation matrices) More...
 
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::SetEchoLevel (int Level)
 Set the Echo Level object Set the echo level of the convergence accelerator. More...
 
int Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::GetEchoLevel ()
 Get the Echo Level object Get the echo level of the convergence accelerator. More...
 
virtual bool Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::IsBlockNewton () const
 Checks if the update direction is unique or double For the current convergence accelerator, this method returns information about the nature of the coupling If it is block Newton, the update is done in both directions. Otherwise, it is done in one direction. More...
 

Protected Access

virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::ComputeJacobianApproximation ()
 
virtual DenseMatrixPointerType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::pGetInverseJacobianApproximation ()
 
virtual std::size_t Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::GetProblemSize () const
 

Life Cycle

 Kratos::Testing::DistributedTestCase::DistributedTestCase ()=delete
 TestCase cannot be created without a name. More...
 
 Kratos::Testing::DistributedTestCase::DistributedTestCase (DistributedTestCase const &rOther)=delete
 The TestCase cannot be copied to avoid duplications. More...
 
 Kratos::Testing::DistributedTestCase::DistributedTestCase (std::string const &Name)
 The constructor to be called. More...
 
 Kratos::Testing::DistributedTestCase::~DistributedTestCase () override
 Destructor. More...
 

Operators

DistributedTestCaseKratos::Testing::DistributedTestCase::operator= (DistributedTestCase const &rOther)=delete
 Preventing the assignment of the tests. More...
 

Operations

void Kratos::Testing::DistributedTestCase::Run () override
 
void Kratos::Testing::DistributedTestCase::Profile () override
 

Inquiry

bool Kratos::Testing::DistributedTestCase::IsEnabled () const override
 
bool Kratos::Testing::DistributedTestCase::IsDisabled () const override
 
bool Kratos::Testing::DistributedTestCase::IsDistributedTest () const override
 

Input and output

std::string Kratos::Testing::DistributedTestCase::Info () const override
 Turn back information as a string. More...
 

Input and output

std::ostream & Kratos::Testing::operator<< (std::ostream &rOStream, const TestCase &rThis)
 output stream function More...
 
std::ostream & Kratos::Testing::operator<< (std::ostream &rOStream, const TestCaseResult &rThis)
 output stream function More...
 
std::istream & Kratos::Testing::operator>> (std::istream &rIStream, TestSuite &rThis)
 input stream function More...
 
std::ostream & Kratos::Testing::operator<< (std::ostream &rOStream, const TestSuite &rThis)
 output stream function More...
 
std::ostream & Kratos::Testing::operator<< (std::ostream &rOStream, const Tester &rThis)
 output stream function More...
 

Life Cycle

 Kratos::InitialState::InitialState (const SizeType Dimension)
 Only defining Dimension constructor. More...
 
 Kratos::InitialState::InitialState (const Vector &rInitialStrainVector, const Vector &rInitialStressVector, const Matrix &rInitialDeformationGradientMatrix)
 
 Kratos::InitialState::InitialState (const Vector &rImposingEntity, const InitialImposingType InitialImposition=InitialImposingType::STRAIN_ONLY)
 
 Kratos::InitialState::InitialState (const Vector &rInitialStrainVector, const Vector &rInitialStressVector)
 
 Kratos::InitialState::InitialState (const Matrix &rInitialDeformationGradientMatrix)
 

Operations

void Kratos::InitialState::SetInitialStrainVector (const Vector &rInitialStrainVector)
 This method sets the initial strain vector. More...
 
void Kratos::InitialState::SetInitialStressVector (const Vector &rInitialStressVector)
 This method sets the initial stress vector. More...
 
void Kratos::InitialState::SetInitialDeformationGradientMatrix (const Matrix &rInitialDeformationGradientMatrix)
 This method sets the initial deformation gradient matrix. More...
 
const VectorKratos::InitialState::GetInitialStrainVector () const
 This method returns the initial strain vector if was set before. More...
 
const VectorKratos::InitialState::GetInitialStressVector () const
 This method returns the initial stress vector if was set before. More...
 
const MatrixKratos::InitialState::GetInitialDeformationGradientMatrix () const
 This method returns the initial stress vector if was set before. More...
 

macros

#define KRATOS_CHECK(IsTrue)   if(!(IsTrue)) KRATOS_ERROR << "Check failed because " << #IsTrue << " is not true" << std::endl;
 
#define KRATOS_CHECK_IS_FALSE(IsFalse)   if(IsFalse) KRATOS_ERROR << "Check failed because " << #IsFalse << " is not false" << std::endl;
 
#define KRATOS_CHECK_EQUAL(a, b)   if(!((a) == (b))) KRATOS_ERROR << "Check failed because " << #a << " is not equal to " << #b
 
#define KRATOS_CHECK_NOT_EQUAL(a, b)   if((a) == (b)) KRATOS_ERROR << "Check failed because " << #a << " is equal to " << #b
 
#define KRATOS_CHECK_STRING_EQUAL(a, b)   if(a.compare(b) != 0) KRATOS_ERROR << "Check failed because \"" << a << "\" is not equal to \"" << b << "\"" << std::endl;
 
#define KRATOS_CHECK_STRING_NOT_EQUAL(a, b)   if(a.compare(b) == 0) KRATOS_ERROR << "Check failed because \"" << a << "\" is equal to \"" << b << "\"" << std::endl;
 
#define KRATOS_CHECK_C_STRING_EQUAL(a, b)   if((strcmp(a,b) != 0)) KRATOS_ERROR << "Check failed because \"" << a << "\" is not equal to \"" << b << "\"" << std::endl;
 
#define KRATOS_CHECK_C_STRING_NOT_EQUAL(a, b)   if((strcmp(a,b) == 0)) KRATOS_ERROR << "Check failed because \"" << a << "\" is equal to \"" << b << "\"" << std::endl;
 
#define KRATOS_CHECK_LESS(a, b)   if(!(a < b)) KRATOS_ERROR << "Check failed because " << #a << " is greater than or equal to " << #b << std::endl;
 
#define KRATOS_CHECK_LESS_EQUAL(a, b)   if(!(a <= b)) KRATOS_ERROR << "Check failed because " << #a << " is greater than " << #b << std::endl;
 
#define KRATOS_CHECK_GREATER(a, b)   if(!(a > b)) KRATOS_ERROR << "Check failed because " << #a << " is less than or equal to " << #b
 
#define KRATOS_CHECK_GREATER_EQUAL(a, b)   if(!(a >= b)) KRATOS_ERROR << "Check failed because " << #a << " is less than " << #b
 
#define KRATOS_CHECK_STRING_CONTAIN_SUB_STRING(TheString, SubString)
 
#define KRATOS_CHECK_NEAR(a, b, tolerance)
 
#define KRATOS_CHECK_RELATIVE_NEAR(a, b, tolerance)
 
#define KRATOS_CHECK_DOUBLE_EQUAL(a, b)   KRATOS_CHECK_NEAR(a,b,std::numeric_limits<double>::epsilon())
 
#define KRATOS_CHECK_VECTOR_NEAR(a, b, tolerance)
 
#define KRATOS_CHECK_VECTOR_RELATIVE_NEAR(a, b, tolerance)
 
#define KRATOS_CHECK_VECTOR_EQUAL(a, b)   KRATOS_CHECK_VECTOR_NEAR(a,b,std::numeric_limits<double>::epsilon())
 
#define KRATOS_CHECK_MATRIX_NEAR(a, b, tolerance)
 
#define KRATOS_CHECK_MATRIX_RELATIVE_NEAR(a, b, tolerance)
 
#define KRATOS_CHECK_MATRIX_EQUAL(a, b)   KRATOS_CHECK_MATRIX_NEAR(a,b,std::numeric_limits<double>::epsilon())
 
#define KRATOS_CHECK_EXCEPTION_IS_THROWN(TheStatement, TheErrorMessage)
 
#define KRATOS_CHECK_VARIABLE_IN_NODAL_DATA(TheVariable, TheNode)
 
#define KRATOS_CHECK_DOF_IN_NODE(TheVariable, TheNode)
 
#define KRATOS_DEBUG_CHECK(IsTrue)   if(false) KRATOS_CHECK(IsTrue)
 
#define KRATOS_DEBUG_CHECK_IS_FALSE(IsFalse)   if(false) KRATOS_CHECK_IS_FALSE(IsFalse)
 
#define KRATOS_DEBUG_CHECK_EQUAL(a, b)   if(false) KRATOS_CHECK_EQUAL(a,b)
 
#define KRATOS_DEBUG_CHECK_NOT_EQUAL(a, b)   if(false) KRATOS_CHECK_NOT_EQUAL(a,b)
 
#define KRATOS_DEBUG_CHECK_C_STRING_EQUAL(a, b)   if(false) KRATOS_CHECK_C_STRING_EQUAL(a,b)
 
#define KRATOS_DEBUG_CHECK_C_STRING_NOT_EQUAL(a, b)   if(false) KRATOS_CHECK_C_STRING_NOT_EQUAL(a,b)
 
#define KRATOS_DEBUG_CHECK_LESS(a, b)   if(false) KRATOS_CHECK_LESS(a,b)
 
#define KRATOS_DEBUG_CHECK_LESS_EQUAL(a, b)   if(false) KRATOS_CHECK_LESS_EQUAL(a,b)
 
#define KRATOS_DEBUG_CHECK_GREATER(a, b)   if(false) KRATOS_CHECK_GREATER(a,b)
 
#define KRATOS_DEBUG_CHECK_GREATER_EQUAL(a, b)   if(false) KRATOS_CHECK_GREATER_EQUAL(a,b)
 
#define KRATOS_DEBUG_CHECK_STRING_CONTAIN_SUB_STRING(TheString, SubString)   if(false) KRATOS_CHECK_STRING_CONTAIN_SUB_STRING(TheString, SubString)
 
#define KRATOS_DEBUG_CHECK_NEAR(a, b, tolerance)   if(false) KRATOS_CHECK_NEAR(a,b, tolerance)
 
#define KRATOS_DEBUG_CHECK_DOUBLE_EQUAL(a, b)   if(false) KRATOS_CHECK_DOUBLE_EQUAL(a,b)
 
#define KRATOS_DEBUG_CHECK_VECTOR_NEAR(a, b, tolerance)   if (false) KRATOS_CHECK_VECTOR_NEAR(a, b, tolerance)
 
#define KRATOS_DEBUG_CHECK_VECTOR_EQUAL(a, b)   if (false) KRATOS_CHECK_VECTOR_EQUAL(a, b)
 
#define KRATOS_DEBUG_CHECK_MATRIX_NEAR(a, b, tolerance)   if (false) KRATOS_CHECK_MATRIX_NEAR(a, b, tolerance)
 
#define KRATOS_DEBUG_CHECK_MATRIX_EQUAL(a, b)   if (false) KRATOS_CHECK_MATRIX_EQUAL(a, b)
 
#define KRATOS_DEBUG_CHECK_EXCEPTION_IS_THROWN(TheStatement, TheErrorMessage)   if(false) KRATOS_CHECK_EXCEPTION_IS_THROWN(TheStatement, TheErrorMessage)
 
#define KRATOS_DEBUG_CHECK_VARIABLE_IN_NODAL_DATA(TheVariable, TheNode)   if(false) KRATOS_CHECK_VARIABLE_IN_NODAL_DATA(TheVariable, TheNode)
 
#define KRATOS_DEBUG_CHECK_DOF_IN_NODE(TheVariable, TheNode)   if(false) KRATOS_CHECK_DOF_IN_NODE(TheVariable, TheNode)
 

Kratos Macros

#define KRATOS_ERROR   throw Kratos::Exception("Error: ", KRATOS_CODE_LOCATION)
 
#define KRATOS_ERROR_IF(conditional)   if(conditional) KRATOS_ERROR
 
#define KRATOS_ERROR_IF_NOT(conditional)   if(!(conditional)) KRATOS_ERROR
 
#define KRATOS_DEBUG_ERROR   if(false) KRATOS_ERROR
 
#define KRATOS_DEBUG_ERROR_IF(conditional)   if(false) KRATOS_ERROR_IF(conditional)
 
#define KRATOS_DEBUG_ERROR_IF_NOT(conditional)   if(false) KRATOS_ERROR_IF_NOT(conditional)
 
#define KRATOS_SKIP_TEST   throw TestSkippedException("Test Skipped: ", KRATOS_CODE_LOCATION)
 
#define KRATOS_SKIP_TEST_IF(conditional)
 
#define KRATOS_SKIP_TEST_IF_NOT(conditional)
 

macros

#define KRATOS_EXPECT_TRUE(IsTrue)   if(!(IsTrue)) KRATOS_ERROR << "Check failed because " << #IsTrue << " is not true" << std::endl;
 
#define KRATOS_EXPECT_FALSE(IsFalse)   if(IsFalse) KRATOS_ERROR << "Check failed because " << #IsFalse << " is not false" << std::endl;
 
#define KRATOS_EXPECT_EQ(a, b)   if(!((a) == (b))) KRATOS_ERROR << "Check failed because " << #a << " is not equal to " << #b
 
#define KRATOS_EXPECT_NE(a, b)   if((a) == (b)) KRATOS_ERROR << "Check failed because " << #a << " is equal to " << #b
 
#define KRATOS_EXPECT_STREQ(a, b)   if((strcmp(a,b) != 0)) KRATOS_ERROR << "Check failed because \"" << a << "\" is not equal to \"" << b << "\"" << std::endl;
 
#define KRATOS_EXPECT_STRNE(a, b)   if((strcmp(a,b) == 0)) KRATOS_ERROR << "Check failed because \"" << a << "\" is equal to \"" << b << "\"" << std::endl;
 
#define KRATOS_EXPECT_LT(a, b)   if(!(a < b)) KRATOS_ERROR << "Check failed because " << #a << " is greater than or equal to " << #b << std::endl;
 
#define KRATOS_EXPECT_LE(a, b)   if(!(a <= b)) KRATOS_ERROR << "Check failed because " << #a << " is greater than " << #b << std::endl;
 
#define KRATOS_EXPECT_GT(a, b)   if(!(a > b)) KRATOS_ERROR << "Check failed because " << #a << " is less than or equal to " << #b
 
#define KRATOS_EXPECT_GE(a, b)   if(!(a >= b)) KRATOS_ERROR << "Check failed because " << #a << " is less than " << #b
 
#define KRATOS_EXPECT_HAS_SUBSTRING(TheString, SubString)
 
#define KRATOS_EXPECT_NEAR(a, b, tolerance)
 
#define KRATOS_EXPECT_RELATIVE_NEAR(a, b, tolerance)
 
#define KRATOS_EXPECT_DOUBLE_EQ(a, b)   KRATOS_EXPECT_NEAR(a,b,std::numeric_limits<double>::epsilon())
 
#define KRATOS_EXPECT_VECTOR_NEAR(a, b, tolerance)
 
#define KRATOS_EXPECT_VECTOR_RELATIVE_NEAR(a, b, tolerance)
 
#define KRATOS_EXPECT_VECTOR_EQ(a, b)   KRATOS_EXPECT_VECTOR_NEAR(a,b,std::numeric_limits<double>::epsilon())
 
#define KRATOS_EXPECT_MATRIX_NEAR(a, b, tolerance)
 
#define KRATOS_EXPECT_MATRIX_RELATIVE_NEAR(a, b, tolerance)
 
#define KRATOS_EXPECT_MATRIX_EQ(a, b)   KRATOS_EXPECT_MATRIX_NEAR(a,b,std::numeric_limits<double>::epsilon())
 
#define KRATOS_EXPECT_EXCEPTION_IS_THROWN(TheStatement, TheErrorMessage)
 
#define KRATOS_EXPECT_VARIABLE_IN_NODAL_DATA(TheVariable, TheNode)
 
#define KRATOS_EXPECT_DOF_IN_NODE(TheVariable, TheNode)
 
#define KRATOS_DEBUG_EXCEPT_EXCEPTION_IS_THROWN(TheStatement, TheErrorMessage)   if(false) KRATOS_EXPECT_EXCEPTION_IS_THROWN(TheStatement, TheErrorMessage)
 

macros

#define KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)    Test##TestCaseName
 
#define KRATOS_TESTING_CONVERT_TO_STRING(Name)   #Name
 
#define KRATOS_TESTING_TEST_CASE_CLASS_BODY(TestCaseName, ParentName)
 
#define KRATOS_TESTING_TEST_CASE_CLASS(TestCaseName, ParentName)
 
#define KRATOS_TEST_CASE(TestCaseName)
 
#define KRATOS_DISABLED_TEST_CASE(TestCaseName)
 
#define KRATOS_TEST_FIXTURE(TestFixtureName)
 
#define KRATOS_TEST_FIXTURE_SETUP(TestFixtureName)   void TestFixtureName::Setup()
 
#define KRATOS_TEST_FIXTURE_TEAR_DOWN(TestFixtureName)   void TestFixtureName::TearDown()
 
#define KRATOS_TEST_CASE_WITH_FIXTURE(TestCaseName, TestFixtureName)
 
#define KRATOS_DISABLED_TEST_CASE_WITH_FIXTURE(TestCaseName, TestFixtureName)
 
#define KRATOS_TESTING_CONCATENATE(a, b)   a##b
 
#define KRATOS_TESTING_CREATE_DUMMY_VARIABLE_NAME(prefix, UniqueNumber)    KRATOS_TESTING_CONCATENATE(prefix, UniqueNumber)
 
#define KRATOS_TESTING_ADD_TEST_TO_TEST_SUITE(TestName, TestSuiteName)
 
#define KRATOS_TESTING_TEST_CASE_IN_SUITE_CLASS(TestCaseName, ParentName)
 
#define KRATOS_TEST_CASE_IN_SUITE(TestCaseName, TestSuiteName)
 
#define KRATOS_DISABLED_TEST_CASE_IN_SUITE(TestCaseName, TestSuiteName)
 
#define KRATOS_DISTRIBUTED_TEST_CASE_IN_SUITE(TestCaseName, TestSuiteName)
 
#define KRATOS_DISABLED_DISTRIBUTED_TEST_CASE_IN_SUITE(TestCaseName, TestSuiteName)
 
#define KRATOS_TEST_CASE_WITH_FIXTURE_IN_SUITE( TestCaseName, TestFixtureName, TestSuiteName)
 
#define KRATOS_DISABLED_TEST_CASE_WITH_FIXTURE_IN_SUITE( TestCaseName, TestFixtureName, TestSuiteName)
 

Detailed Description

The Kratos core comprises a basic set of classes used by all applications.

Macro Definition Documentation

◆ KRATOS_CHECK

#define KRATOS_CHECK (   IsTrue)    if(!(IsTrue)) KRATOS_ERROR << "Check failed because " << #IsTrue << " is not true" << std::endl;

◆ KRATOS_CHECK_C_STRING_EQUAL

#define KRATOS_CHECK_C_STRING_EQUAL (   a,
 
)    if((strcmp(a,b) != 0)) KRATOS_ERROR << "Check failed because \"" << a << "\" is not equal to \"" << b << "\"" << std::endl;

◆ KRATOS_CHECK_C_STRING_NOT_EQUAL

#define KRATOS_CHECK_C_STRING_NOT_EQUAL (   a,
 
)    if((strcmp(a,b) == 0)) KRATOS_ERROR << "Check failed because \"" << a << "\" is equal to \"" << b << "\"" << std::endl;

◆ KRATOS_CHECK_DOF_IN_NODE

#define KRATOS_CHECK_DOF_IN_NODE (   TheVariable,
  TheNode 
)
Value:
KRATOS_ERROR_IF_NOT(TheNode.HasDofFor(TheVariable)) \
<< "Missing Degree of Freedom for " << TheVariable.Name() \
<< " in node " << TheNode.Id() << "." << std::endl;
#define KRATOS_ERROR_IF_NOT(conditional)
Definition: exception.h:163

◆ KRATOS_CHECK_DOUBLE_EQUAL

#define KRATOS_CHECK_DOUBLE_EQUAL (   a,
 
)    KRATOS_CHECK_NEAR(a,b,std::numeric_limits<double>::epsilon())

◆ KRATOS_CHECK_EQUAL

#define KRATOS_CHECK_EQUAL (   a,
 
)    if(!((a) == (b))) KRATOS_ERROR << "Check failed because " << #a << " is not equal to " << #b

◆ KRATOS_CHECK_EXCEPTION_IS_THROWN

#define KRATOS_CHECK_EXCEPTION_IS_THROWN (   TheStatement,
  TheErrorMessage 
)
Value:
try { \
TheStatement; \
KRATOS_ERROR << #TheStatement << " exited without throwing an error." << std::endl; \
} catch (Kratos::Exception& e) { \
if ( std::string(e.what()).find( TheErrorMessage ) == std::string::npos ) \
KRATOS_ERROR \
<< "Test Failed: " << #TheStatement \
<< " did not throw the expected error." << std::endl \
<< "Expected:" << std::endl << TheErrorMessage << std::endl \
<< "Got:" << std::endl << e.what() << std::endl; \
}
Extends the std::exception class with more information about error location.
Definition: exception.h:49
e
Definition: run_cpp_mpi_tests.py:31

◆ KRATOS_CHECK_GREATER

#define KRATOS_CHECK_GREATER (   a,
 
)    if(!(a > b)) KRATOS_ERROR << "Check failed because " << #a << " is less than or equal to " << #b

◆ KRATOS_CHECK_GREATER_EQUAL

#define KRATOS_CHECK_GREATER_EQUAL (   a,
 
)    if(!(a >= b)) KRATOS_ERROR << "Check failed because " << #a << " is less than " << #b

◆ KRATOS_CHECK_IS_FALSE

#define KRATOS_CHECK_IS_FALSE (   IsFalse)    if(IsFalse) KRATOS_ERROR << "Check failed because " << #IsFalse << " is not false" << std::endl;

◆ KRATOS_CHECK_LESS

#define KRATOS_CHECK_LESS (   a,
 
)    if(!(a < b)) KRATOS_ERROR << "Check failed because " << #a << " is greater than or equal to " << #b << std::endl;

◆ KRATOS_CHECK_LESS_EQUAL

#define KRATOS_CHECK_LESS_EQUAL (   a,
 
)    if(!(a <= b)) KRATOS_ERROR << "Check failed because " << #a << " is greater than " << #b << std::endl;

◆ KRATOS_CHECK_MATRIX_EQUAL

#define KRATOS_CHECK_MATRIX_EQUAL (   a,
 
)    KRATOS_CHECK_MATRIX_NEAR(a,b,std::numeric_limits<double>::epsilon())

◆ KRATOS_CHECK_MATRIX_NEAR

#define KRATOS_CHECK_MATRIX_NEAR (   a,
  b,
  tolerance 
)
Value:
{ \
KRATOS_ERROR_IF_NOT((a.size1() == b.size1()) && (a.size2() == b.size2())) \
<< "Check failed because matrix arguments do not have the same dimensions:" \
<< std::endl \
<< "First argument has dimensions (" << a.size1() << "," << a.size2() << "), " \
<< "second argument has dimensions (" << b.size1() << "," << b.size2() << ")." \
<< std::endl; \
for (std::size_t _i = 0; _i < a.size1(); _i++) { \
for (std::size_t _j = 0; _j < a.size2(); _j++) { \
KRATOS_ERROR_IF( !(std::abs(a(_i,_j) - b(_i,_j)) <= tolerance) ) \
<< "Check failed because matrix " << #a << " with values" << std::endl \
<< a << std::endl \
<< "Is not near matrix " << #b << " with values" << std::endl \
<< b << std::endl \
<< "Mismatch found in component (" << _i << "," << _j << "): " << std::endl \
<< a(_i,_j) << " not near " << b(_i,_j) \
<< " within tolerance " << tolerance << "." << std::endl; \
} \
} \
}
a
Definition: generate_stokes_twofluid_element.py:77
b
Definition: generate_total_lagrangian_mixed_volumetric_strain_element.py:31

◆ KRATOS_CHECK_MATRIX_RELATIVE_NEAR

#define KRATOS_CHECK_MATRIX_RELATIVE_NEAR (   a,
  b,
  tolerance 
)

◆ KRATOS_CHECK_NEAR

#define KRATOS_CHECK_NEAR (   a,
  b,
  tolerance 
)
Value:
if(!(std::abs(a - b) <= tolerance)) KRATOS_ERROR << "Check failed because " << #a << " = " << a << \
" is not near to " << #b << " = " << b << " within the tolerance " << tolerance
#define KRATOS_ERROR
Definition: exception.h:161

◆ KRATOS_CHECK_NOT_EQUAL

#define KRATOS_CHECK_NOT_EQUAL (   a,
 
)    if((a) == (b)) KRATOS_ERROR << "Check failed because " << #a << " is equal to " << #b

◆ KRATOS_CHECK_RELATIVE_NEAR

#define KRATOS_CHECK_RELATIVE_NEAR (   a,
  b,
  tolerance 
)
Value:
if(!(std::abs(b) <= std::numeric_limits<double>::epsilon())) { KRATOS_ERROR_IF(!(std::abs((a - b)/b) <= tolerance)) << "Check failed because " << #a << " = " << a << \
" is not near to " << #b << " = " << b << " within the relative tolerance " << tolerance << std::endl; } else {KRATOS_CHECK_NEAR(a,b,tolerance);}
#define KRATOS_CHECK_NEAR(a, b, tolerance)
Definition: checks.h:52
#define KRATOS_ERROR_IF(conditional)
Definition: exception.h:162

◆ KRATOS_CHECK_STRING_CONTAIN_SUB_STRING

#define KRATOS_CHECK_STRING_CONTAIN_SUB_STRING (   TheString,
  SubString 
)
Value:
if (TheString.find(SubString) == std::string::npos ) \
KRATOS_ERROR << "The string \"" << SubString << "\" was not found in the given string" << std::endl;

◆ KRATOS_CHECK_STRING_EQUAL

#define KRATOS_CHECK_STRING_EQUAL (   a,
 
)    if(a.compare(b) != 0) KRATOS_ERROR << "Check failed because \"" << a << "\" is not equal to \"" << b << "\"" << std::endl;

◆ KRATOS_CHECK_STRING_NOT_EQUAL

#define KRATOS_CHECK_STRING_NOT_EQUAL (   a,
 
)    if(a.compare(b) == 0) KRATOS_ERROR << "Check failed because \"" << a << "\" is equal to \"" << b << "\"" << std::endl;

◆ KRATOS_CHECK_VARIABLE_IN_NODAL_DATA

#define KRATOS_CHECK_VARIABLE_IN_NODAL_DATA (   TheVariable,
  TheNode 
)
Value:
KRATOS_ERROR_IF_NOT(TheNode.SolutionStepsDataHas(TheVariable)) \
<< "Missing " << TheVariable.Name() << " variable in solution step data for node " \
<< TheNode.Id() << "." << std::endl;

◆ KRATOS_CHECK_VECTOR_EQUAL

#define KRATOS_CHECK_VECTOR_EQUAL (   a,
 
)    KRATOS_CHECK_VECTOR_NEAR(a,b,std::numeric_limits<double>::epsilon())

◆ KRATOS_CHECK_VECTOR_NEAR

#define KRATOS_CHECK_VECTOR_NEAR (   a,
  b,
  tolerance 
)
Value:
{ \
KRATOS_ERROR_IF_NOT(a.size() == b.size()) \
<< "Check failed because vector arguments do not have the same size:" \
<< std::endl \
<< "First argument has size " << a.size() << ", " \
<< "second argument has size " << b.size() << "." << std::endl; \
for (std::size_t _i = 0; _i < a.size(); _i++) { \
KRATOS_ERROR_IF( !(std::abs(a[_i] - b[_i]) <= tolerance) ) \
<< "Check failed because vector " << #a << " with values" << std::endl \
<< a << std::endl \
<< "Is not near vector " << #b << " with values" << std::endl \
<< b << std::endl \
<< "Mismatch found in component " << _i << ":" << std::endl \
<< a[_i] << " not near " << b[_i] \
<< " within tolerance " << tolerance << "." << std::endl; \
} \
}

◆ KRATOS_CHECK_VECTOR_RELATIVE_NEAR

#define KRATOS_CHECK_VECTOR_RELATIVE_NEAR (   a,
  b,
  tolerance 
)
Value:
{ \
KRATOS_ERROR_IF_NOT(a.size() == b.size()) \
<< "Check failed because vector arguments do not have the same size:" \
<< std::endl \
<< "First argument has size " << a.size() << ", " \
<< "second argument has size " << b.size() << "." << std::endl; \
for (std::size_t _i = 0; _i < a.size(); _i++) { \
if (std::abs(b[_i]) > std::numeric_limits<double>::epsilon()) { \
KRATOS_ERROR_IF( !(std::abs((a[_i] - b[_i])/b[_i]) <= tolerance) ) \
<< "Check failed because vector " << #a << " with values" << std::endl \
<< a << std::endl \
<< "Is not near vector " << #b << " with values" << std::endl \
<< b << std::endl \
<< "Mismatch found in component " << _i << ":" << std::endl \
<< a[_i] << " not near " << b[_i] \
<< " within relative tolerance " << tolerance << "." << std::endl; \
} else { \
KRATOS_ERROR_IF( !(std::abs(a[_i] - b[_i]) <= tolerance) ) \
<< "Check failed because vector " << #a << " with values" << std::endl \
<< a << std::endl \
<< "Is not near vector " << #b << " with values" << std::endl \
<< b << std::endl \
<< "Mismatch found in component " << _i << ":" << std::endl \
<< a[_i] << " not near " << b[_i] \
<< " within tolerance " << tolerance << "." << std::endl; \
} \
} \
}

◆ KRATOS_DEBUG_CHECK

#define KRATOS_DEBUG_CHECK (   IsTrue)    if(false) KRATOS_CHECK(IsTrue)

◆ KRATOS_DEBUG_CHECK_C_STRING_EQUAL

#define KRATOS_DEBUG_CHECK_C_STRING_EQUAL (   a,
 
)    if(false) KRATOS_CHECK_C_STRING_EQUAL(a,b)

◆ KRATOS_DEBUG_CHECK_C_STRING_NOT_EQUAL

#define KRATOS_DEBUG_CHECK_C_STRING_NOT_EQUAL (   a,
 
)    if(false) KRATOS_CHECK_C_STRING_NOT_EQUAL(a,b)

◆ KRATOS_DEBUG_CHECK_DOF_IN_NODE

#define KRATOS_DEBUG_CHECK_DOF_IN_NODE (   TheVariable,
  TheNode 
)    if(false) KRATOS_CHECK_DOF_IN_NODE(TheVariable, TheNode)

◆ KRATOS_DEBUG_CHECK_DOUBLE_EQUAL

#define KRATOS_DEBUG_CHECK_DOUBLE_EQUAL (   a,
 
)    if(false) KRATOS_CHECK_DOUBLE_EQUAL(a,b)

◆ KRATOS_DEBUG_CHECK_EQUAL

#define KRATOS_DEBUG_CHECK_EQUAL (   a,
 
)    if(false) KRATOS_CHECK_EQUAL(a,b)

◆ KRATOS_DEBUG_CHECK_EXCEPTION_IS_THROWN

#define KRATOS_DEBUG_CHECK_EXCEPTION_IS_THROWN (   TheStatement,
  TheErrorMessage 
)    if(false) KRATOS_CHECK_EXCEPTION_IS_THROWN(TheStatement, TheErrorMessage)

◆ KRATOS_DEBUG_CHECK_GREATER

#define KRATOS_DEBUG_CHECK_GREATER (   a,
 
)    if(false) KRATOS_CHECK_GREATER(a,b)

◆ KRATOS_DEBUG_CHECK_GREATER_EQUAL

#define KRATOS_DEBUG_CHECK_GREATER_EQUAL (   a,
 
)    if(false) KRATOS_CHECK_GREATER_EQUAL(a,b)

◆ KRATOS_DEBUG_CHECK_IS_FALSE

#define KRATOS_DEBUG_CHECK_IS_FALSE (   IsFalse)    if(false) KRATOS_CHECK_IS_FALSE(IsFalse)

◆ KRATOS_DEBUG_CHECK_LESS

#define KRATOS_DEBUG_CHECK_LESS (   a,
 
)    if(false) KRATOS_CHECK_LESS(a,b)

◆ KRATOS_DEBUG_CHECK_LESS_EQUAL

#define KRATOS_DEBUG_CHECK_LESS_EQUAL (   a,
 
)    if(false) KRATOS_CHECK_LESS_EQUAL(a,b)

◆ KRATOS_DEBUG_CHECK_MATRIX_EQUAL

#define KRATOS_DEBUG_CHECK_MATRIX_EQUAL (   a,
 
)    if (false) KRATOS_CHECK_MATRIX_EQUAL(a, b)

◆ KRATOS_DEBUG_CHECK_MATRIX_NEAR

#define KRATOS_DEBUG_CHECK_MATRIX_NEAR (   a,
  b,
  tolerance 
)    if (false) KRATOS_CHECK_MATRIX_NEAR(a, b, tolerance)

◆ KRATOS_DEBUG_CHECK_NEAR

#define KRATOS_DEBUG_CHECK_NEAR (   a,
  b,
  tolerance 
)    if(false) KRATOS_CHECK_NEAR(a,b, tolerance)

◆ KRATOS_DEBUG_CHECK_NOT_EQUAL

#define KRATOS_DEBUG_CHECK_NOT_EQUAL (   a,
 
)    if(false) KRATOS_CHECK_NOT_EQUAL(a,b)

◆ KRATOS_DEBUG_CHECK_STRING_CONTAIN_SUB_STRING

#define KRATOS_DEBUG_CHECK_STRING_CONTAIN_SUB_STRING (   TheString,
  SubString 
)    if(false) KRATOS_CHECK_STRING_CONTAIN_SUB_STRING(TheString, SubString)

◆ KRATOS_DEBUG_CHECK_VARIABLE_IN_NODAL_DATA

#define KRATOS_DEBUG_CHECK_VARIABLE_IN_NODAL_DATA (   TheVariable,
  TheNode 
)    if(false) KRATOS_CHECK_VARIABLE_IN_NODAL_DATA(TheVariable, TheNode)

◆ KRATOS_DEBUG_CHECK_VECTOR_EQUAL

#define KRATOS_DEBUG_CHECK_VECTOR_EQUAL (   a,
 
)    if (false) KRATOS_CHECK_VECTOR_EQUAL(a, b)

◆ KRATOS_DEBUG_CHECK_VECTOR_NEAR

#define KRATOS_DEBUG_CHECK_VECTOR_NEAR (   a,
  b,
  tolerance 
)    if (false) KRATOS_CHECK_VECTOR_NEAR(a, b, tolerance)

◆ KRATOS_DEBUG_ERROR

#define KRATOS_DEBUG_ERROR   if(false) KRATOS_ERROR

◆ KRATOS_DEBUG_ERROR_IF

#define KRATOS_DEBUG_ERROR_IF (   conditional)    if(false) KRATOS_ERROR_IF(conditional)

◆ KRATOS_DEBUG_ERROR_IF_NOT

#define KRATOS_DEBUG_ERROR_IF_NOT (   conditional)    if(false) KRATOS_ERROR_IF_NOT(conditional)

◆ KRATOS_DEBUG_EXCEPT_EXCEPTION_IS_THROWN

#define KRATOS_DEBUG_EXCEPT_EXCEPTION_IS_THROWN (   TheStatement,
  TheErrorMessage 
)    if(false) KRATOS_EXPECT_EXCEPTION_IS_THROWN(TheStatement, TheErrorMessage)

◆ KRATOS_DISABLED_DISTRIBUTED_TEST_CASE_IN_SUITE

#define KRATOS_DISABLED_DISTRIBUTED_TEST_CASE_IN_SUITE (   TestCaseName,
  TestSuiteName 
)
Value:
KRATOS_TESTING_TEST_CASE_IN_SUITE_CLASS(TestCaseName, DistributedTestCase) \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)> \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::mDummy(true); \
const Kratos::Testing::Internals::AddThisTestToTestSuite \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::mAnotherDummy = \
Kratos::Testing::Internals::AddThisTestToTestSuite( \
KRATOS_TESTING_CONVERT_TO_STRING(Test##TestCaseName), \
\
void KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::TestFunction()
#define KRATOS_TESTING_CONVERT_TO_STRING(Name)
Definition: test_case.h:191
#define KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)
Definition: test_case.h:188
#define KRATOS_TESTING_TEST_CASE_IN_SUITE_CLASS(TestCaseName, ParentName)
Definition: test_suite.h:168
REF: G. R. Cowper, GAUSSIAN QUADRATURE FORMULAS FOR TRIANGLES.
Definition: mesh_condition.cpp:21

◆ KRATOS_DISABLED_TEST_CASE

#define KRATOS_DISABLED_TEST_CASE (   TestCaseName)
Value:
KRATOS_TESTING_TEST_CASE_CLASS(TestCaseName, TestCase) \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::mDummy(true); \
\
void KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::TestFunction()
#define KRATOS_TESTING_TEST_CASE_CLASS(TestCaseName, ParentName)
Definition: test_case.h:200

◆ KRATOS_DISABLED_TEST_CASE_IN_SUITE

#define KRATOS_DISABLED_TEST_CASE_IN_SUITE (   TestCaseName,
  TestSuiteName 
)
Value:
KRATOS_TESTING_TEST_CASE_IN_SUITE_CLASS(TestCaseName, TestCase) \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)> \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::mDummy(true); \
const Kratos::Testing::Internals::AddThisTestToTestSuite \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::mAnotherDummy = \
Kratos::Testing::Internals::AddThisTestToTestSuite( \
KRATOS_TESTING_CONVERT_TO_STRING(Test##TestCaseName), \
\
void KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::TestFunction()

◆ KRATOS_DISABLED_TEST_CASE_WITH_FIXTURE

#define KRATOS_DISABLED_TEST_CASE_WITH_FIXTURE (   TestCaseName,
  TestFixtureName 
)
Value:
KRATOS_TESTING_TEST_CASE_CLASS(TestCaseName, TestFixtureName) \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::mDummy(true); \
\
void KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::TestFunction()

◆ KRATOS_DISABLED_TEST_CASE_WITH_FIXTURE_IN_SUITE

#define KRATOS_DISABLED_TEST_CASE_WITH_FIXTURE_IN_SUITE (   TestCaseName,
  TestFixtureName,
  TestSuiteName 
)
Value:
KRATOS_TESTING_TEST_CASE_IN_SUITE_CLASS(TestCaseName, TestFixtureName) \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)> \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::mDummy(true); \
const Kratos::Testing::Internals::AddThisTestToTestSuite \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::mAnotherDummy = \
Kratos::Testing::Internals::AddThisTestToTestSuite( \
KRATOS_TESTING_CONVERT_TO_STRING(Test##TestCaseName), \
\
void KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::TestFunction()

◆ KRATOS_DISTRIBUTED_TEST_CASE_IN_SUITE

#define KRATOS_DISTRIBUTED_TEST_CASE_IN_SUITE (   TestCaseName,
  TestSuiteName 
)
Value:
KRATOS_TESTING_TEST_CASE_IN_SUITE_CLASS(TestCaseName, DistributedTestCase) \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)> \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::mDummy; \
const Kratos::Testing::Internals::AddThisTestToTestSuite \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::mAnotherDummy = \
Kratos::Testing::Internals::AddThisTestToTestSuite( \
KRATOS_TESTING_CONVERT_TO_STRING(Test##TestCaseName), \
\
void KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::TestFunction()

◆ KRATOS_ERROR

#define KRATOS_ERROR   throw Kratos::Exception("Error: ", KRATOS_CODE_LOCATION)

◆ KRATOS_ERROR_IF

#define KRATOS_ERROR_IF (   conditional)    if(conditional) KRATOS_ERROR

◆ KRATOS_ERROR_IF_NOT

#define KRATOS_ERROR_IF_NOT (   conditional)    if(!(conditional)) KRATOS_ERROR

◆ KRATOS_EXPECT_DOF_IN_NODE

#define KRATOS_EXPECT_DOF_IN_NODE (   TheVariable,
  TheNode 
)
Value:
KRATOS_ERROR_IF_NOT(TheNode.HasDofFor(TheVariable)) \
<< "Missing Degree of Freedom for " << TheVariable.Name() \
<< " in node " << TheNode.Id() << "." << std::endl;

◆ KRATOS_EXPECT_DOUBLE_EQ

#define KRATOS_EXPECT_DOUBLE_EQ (   a,
 
)    KRATOS_EXPECT_NEAR(a,b,std::numeric_limits<double>::epsilon())

◆ KRATOS_EXPECT_EQ

#define KRATOS_EXPECT_EQ (   a,
 
)    if(!((a) == (b))) KRATOS_ERROR << "Check failed because " << #a << " is not equal to " << #b

◆ KRATOS_EXPECT_EXCEPTION_IS_THROWN

#define KRATOS_EXPECT_EXCEPTION_IS_THROWN (   TheStatement,
  TheErrorMessage 
)
Value:
try { \
TheStatement; \
KRATOS_ERROR << #TheStatement << " exited without throwing an error." << std::endl; \
} catch (Kratos::Exception& e) { \
if ( std::string(e.what()).find( TheErrorMessage ) == std::string::npos ) \
KRATOS_ERROR \
<< "Test Failed: " << #TheStatement \
<< " did not throw the expected error." << std::endl \
<< "Expected:" << std::endl << TheErrorMessage << std::endl \
<< "Got:" << std::endl << e.what() << std::endl; \
}

◆ KRATOS_EXPECT_FALSE

#define KRATOS_EXPECT_FALSE (   IsFalse)    if(IsFalse) KRATOS_ERROR << "Check failed because " << #IsFalse << " is not false" << std::endl;

◆ KRATOS_EXPECT_GE

#define KRATOS_EXPECT_GE (   a,
 
)    if(!(a >= b)) KRATOS_ERROR << "Check failed because " << #a << " is less than " << #b

◆ KRATOS_EXPECT_GT

#define KRATOS_EXPECT_GT (   a,
 
)    if(!(a > b)) KRATOS_ERROR << "Check failed because " << #a << " is less than or equal to " << #b

◆ KRATOS_EXPECT_HAS_SUBSTRING

#define KRATOS_EXPECT_HAS_SUBSTRING (   TheString,
  SubString 
)
Value:
if (TheString.find(SubString) == std::string::npos ) \
KRATOS_ERROR << "The string \"" << SubString << "\" was not found in the given string" << std::endl;

◆ KRATOS_EXPECT_LE

#define KRATOS_EXPECT_LE (   a,
 
)    if(!(a <= b)) KRATOS_ERROR << "Check failed because " << #a << " is greater than " << #b << std::endl;

◆ KRATOS_EXPECT_LT

#define KRATOS_EXPECT_LT (   a,
 
)    if(!(a < b)) KRATOS_ERROR << "Check failed because " << #a << " is greater than or equal to " << #b << std::endl;

◆ KRATOS_EXPECT_MATRIX_EQ

#define KRATOS_EXPECT_MATRIX_EQ (   a,
 
)    KRATOS_EXPECT_MATRIX_NEAR(a,b,std::numeric_limits<double>::epsilon())

◆ KRATOS_EXPECT_MATRIX_NEAR

#define KRATOS_EXPECT_MATRIX_NEAR (   a,
  b,
  tolerance 
)
Value:
{ \
KRATOS_ERROR_IF_NOT((a.size1() == b.size1()) && (a.size2() == b.size2())) \
<< "Check failed because matrix arguments do not have the same dimensions:" \
<< std::endl \
<< "First argument has dimensions (" << a.size1() << "," << a.size2() << "), " \
<< "second argument has dimensions (" << b.size1() << "," << b.size2() << ")." \
<< std::endl; \
for (std::size_t _i = 0; _i < a.size1(); _i++) { \
for (std::size_t _j = 0; _j < a.size2(); _j++) { \
KRATOS_ERROR_IF( !(std::abs(a(_i,_j) - b(_i,_j)) <= tolerance) ) \
<< "Check failed because matrix " << #a << " with values" << std::endl \
<< a << std::endl \
<< "Is not near matrix " << #b << " with values" << std::endl \
<< b << std::endl \
<< "Mismatch found in component (" << _i << "," << _j << "): " << std::endl \
<< a(_i,_j) << " not near " << b(_i,_j) \
<< " within tolerance " << tolerance << "." << std::endl; \
} \
} \
}

◆ KRATOS_EXPECT_MATRIX_RELATIVE_NEAR

#define KRATOS_EXPECT_MATRIX_RELATIVE_NEAR (   a,
  b,
  tolerance 
)

◆ KRATOS_EXPECT_NE

#define KRATOS_EXPECT_NE (   a,
 
)    if((a) == (b)) KRATOS_ERROR << "Check failed because " << #a << " is equal to " << #b

◆ KRATOS_EXPECT_NEAR

#define KRATOS_EXPECT_NEAR (   a,
  b,
  tolerance 
)
Value:
if(!(std::abs(a - b) <= tolerance)) KRATOS_ERROR << "Check failed because " << #a << " = " << a << \
" is not near to " << #b << " = " << b << " within the tolerance " << tolerance

◆ KRATOS_EXPECT_RELATIVE_NEAR

#define KRATOS_EXPECT_RELATIVE_NEAR (   a,
  b,
  tolerance 
)
Value:
if(!(std::abs(b) <= std::numeric_limits<double>::epsilon())) { KRATOS_ERROR_IF(!(std::abs((a - b)/b) <= tolerance)) << "Check failed because " << #a << " = " << a << \
" is not near to " << #b << " = " << b << " within the relative tolerance " << tolerance << std::endl; } else {KRATOS_EXPECT_NEAR(a,b,tolerance);}
#define KRATOS_EXPECT_NEAR(a, b, tolerance)
Definition: expect.h:51

◆ KRATOS_EXPECT_STREQ

#define KRATOS_EXPECT_STREQ (   a,
 
)    if((strcmp(a,b) != 0)) KRATOS_ERROR << "Check failed because \"" << a << "\" is not equal to \"" << b << "\"" << std::endl;

◆ KRATOS_EXPECT_STRNE

#define KRATOS_EXPECT_STRNE (   a,
 
)    if((strcmp(a,b) == 0)) KRATOS_ERROR << "Check failed because \"" << a << "\" is equal to \"" << b << "\"" << std::endl;

◆ KRATOS_EXPECT_TRUE

#define KRATOS_EXPECT_TRUE (   IsTrue)    if(!(IsTrue)) KRATOS_ERROR << "Check failed because " << #IsTrue << " is not true" << std::endl;

◆ KRATOS_EXPECT_VARIABLE_IN_NODAL_DATA

#define KRATOS_EXPECT_VARIABLE_IN_NODAL_DATA (   TheVariable,
  TheNode 
)
Value:
KRATOS_ERROR_IF_NOT(TheNode.SolutionStepsDataHas(TheVariable)) \
<< "Missing " << TheVariable.Name() << " variable in solution step data for node " \
<< TheNode.Id() << "." << std::endl;

◆ KRATOS_EXPECT_VECTOR_EQ

#define KRATOS_EXPECT_VECTOR_EQ (   a,
 
)    KRATOS_EXPECT_VECTOR_NEAR(a,b,std::numeric_limits<double>::epsilon())

◆ KRATOS_EXPECT_VECTOR_NEAR

#define KRATOS_EXPECT_VECTOR_NEAR (   a,
  b,
  tolerance 
)
Value:
{ \
KRATOS_ERROR_IF_NOT(a.size() == b.size()) \
<< "Check failed because vector arguments do not have the same size:" \
<< std::endl \
<< "First argument has size " << a.size() << ", " \
<< "second argument has size " << b.size() << "." << std::endl; \
for (std::size_t _i = 0; _i < a.size(); _i++) { \
KRATOS_ERROR_IF( !(std::abs(a[_i] - b[_i]) <= tolerance) ) \
<< "Check failed because vector " << #a << " with values" << std::endl \
<< a << std::endl \
<< "Is not near vector " << #b << " with values" << std::endl \
<< b << std::endl \
<< "Mismatch found in component " << _i << ":" << std::endl \
<< a[_i] << " not near " << b[_i] \
<< " within tolerance " << tolerance << "." << std::endl; \
} \
}

◆ KRATOS_EXPECT_VECTOR_RELATIVE_NEAR

#define KRATOS_EXPECT_VECTOR_RELATIVE_NEAR (   a,
  b,
  tolerance 
)
Value:
{ \
KRATOS_ERROR_IF_NOT(a.size() == b.size()) \
<< "Check failed because vector arguments do not have the same size:" \
<< std::endl \
<< "First argument has size " << a.size() << ", " \
<< "second argument has size " << b.size() << "." << std::endl; \
for (std::size_t _i = 0; _i < a.size(); _i++) { \
if (std::abs(b[_i]) > std::numeric_limits<double>::epsilon()) { \
KRATOS_ERROR_IF( !(std::abs((a[_i] - b[_i])/b[_i]) <= tolerance) ) \
<< "Check failed because vector " << #a << " with values" << std::endl \
<< a << std::endl \
<< "Is not near vector " << #b << " with values" << std::endl \
<< b << std::endl \
<< "Mismatch found in component " << _i << ":" << std::endl \
<< a[_i] << " not near " << b[_i] \
<< " within relative tolerance " << tolerance << "." << std::endl; \
} else { \
KRATOS_ERROR_IF( !(std::abs(a[_i] - b[_i]) <= tolerance) ) \
<< "Check failed because vector " << #a << " with values" << std::endl \
<< a << std::endl \
<< "Is not near vector " << #b << " with values" << std::endl \
<< b << std::endl \
<< "Mismatch found in component " << _i << ":" << std::endl \
<< a[_i] << " not near " << b[_i] \
<< " within tolerance " << tolerance << "." << std::endl; \
} \
} \
}

◆ KRATOS_SKIP_TEST

#define KRATOS_SKIP_TEST   throw TestSkippedException("Test Skipped: ", KRATOS_CODE_LOCATION)

◆ KRATOS_SKIP_TEST_IF

#define KRATOS_SKIP_TEST_IF (   conditional)
Value:
if (conditional) \
throw TestSkippedException("Test Skipped: ", KRATOS_CODE_LOCATION)
#define KRATOS_CODE_LOCATION
Definition: code_location.h:133

◆ KRATOS_SKIP_TEST_IF_NOT

#define KRATOS_SKIP_TEST_IF_NOT (   conditional)
Value:
if (!(conditional)) \
throw TestSkippedException("Test Skipped: ", KRATOS_CODE_LOCATION)

◆ KRATOS_TEST_CASE

#define KRATOS_TEST_CASE (   TestCaseName)
Value:
KRATOS_TESTING_TEST_CASE_CLASS(TestCaseName, TestCase) \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::mDummy; \
\
void KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::TestFunction()

◆ KRATOS_TEST_CASE_IN_SUITE

#define KRATOS_TEST_CASE_IN_SUITE (   TestCaseName,
  TestSuiteName 
)
Value:
KRATOS_TESTING_TEST_CASE_IN_SUITE_CLASS(TestCaseName, TestCase) \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)> \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::mDummy; \
const Kratos::Testing::Internals::AddThisTestToTestSuite \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::mAnotherDummy = \
Kratos::Testing::Internals::AddThisTestToTestSuite( \
KRATOS_TESTING_CONVERT_TO_STRING(Test##TestCaseName), \
\
void KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::TestFunction()

◆ KRATOS_TEST_CASE_WITH_FIXTURE

#define KRATOS_TEST_CASE_WITH_FIXTURE (   TestCaseName,
  TestFixtureName 
)
Value:
KRATOS_TESTING_TEST_CASE_CLASS(TestCaseName, TestFixtureName) \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::mDummy; \
\
void KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::TestFunction()

◆ KRATOS_TEST_CASE_WITH_FIXTURE_IN_SUITE

#define KRATOS_TEST_CASE_WITH_FIXTURE_IN_SUITE (   TestCaseName,
  TestFixtureName,
  TestSuiteName 
)
Value:
KRATOS_TESTING_TEST_CASE_IN_SUITE_CLASS(TestCaseName, TestFixtureName) \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)> \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::mDummy; \
const Kratos::Testing::Internals::AddThisTestToTestSuite \
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::mAnotherDummy = \
Kratos::Testing::Internals::AddThisTestToTestSuite( \
KRATOS_TESTING_CONVERT_TO_STRING(Test##TestCaseName), \
\
void KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)::TestFunction()

◆ KRATOS_TEST_FIXTURE

#define KRATOS_TEST_FIXTURE (   TestFixtureName)
Value:
class TestFixtureName : public TestCase \
{\
public:\
TestFixtureName(std::string const& Name) : TestCase(Name) {}\
private: \
void Setup() override; \
void TearDown() override; \
};

◆ KRATOS_TEST_FIXTURE_SETUP

#define KRATOS_TEST_FIXTURE_SETUP (   TestFixtureName)    void TestFixtureName::Setup()

◆ KRATOS_TEST_FIXTURE_TEAR_DOWN

#define KRATOS_TEST_FIXTURE_TEAR_DOWN (   TestFixtureName)    void TestFixtureName::TearDown()

◆ KRATOS_TESTING_ADD_TEST_TO_TEST_SUITE

#define KRATOS_TESTING_ADD_TEST_TO_TEST_SUITE (   TestName,
  TestSuiteName 
)
Value:
Kratos::Testing::Internals::AddThisTestToTestSuite \
KRATOS_TESTING_CREATE_DUMMY_VARIABLE_NAME(dummy, __LINE__)( \
TestName, TestSuiteName)
dummy
Definition: script.py:194

◆ KRATOS_TESTING_CONCATENATE

#define KRATOS_TESTING_CONCATENATE (   a,
 
)    a##b

◆ KRATOS_TESTING_CONVERT_TO_STRING

#define KRATOS_TESTING_CONVERT_TO_STRING (   Name)    #Name

◆ KRATOS_TESTING_CREATE_CLASS_NAME

#define KRATOS_TESTING_CREATE_CLASS_NAME (   TestCaseName)     Test##TestCaseName

◆ KRATOS_TESTING_CREATE_DUMMY_VARIABLE_NAME

#define KRATOS_TESTING_CREATE_DUMMY_VARIABLE_NAME (   prefix,
  UniqueNumber 
)     KRATOS_TESTING_CONCATENATE(prefix, UniqueNumber)

◆ KRATOS_TESTING_TEST_CASE_CLASS

#define KRATOS_TESTING_TEST_CASE_CLASS (   TestCaseName,
  ParentName 
)
Value:
class KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName) : public ParentName \
{\
KRATOS_TESTING_TEST_CASE_CLASS_BODY(TestCaseName,ParentName) \
};

◆ KRATOS_TESTING_TEST_CASE_CLASS_BODY

#define KRATOS_TESTING_TEST_CASE_CLASS_BODY (   TestCaseName,
  ParentName 
)
Value:
public:\
KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName)() : ParentName(KRATOS_TESTING_CONVERT_TO_STRING(Test##TestCaseName)) {}\
private: \
void TestFunction() override; \
static const Internals::RegisterThisTest< KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName) > mDummy;

◆ KRATOS_TESTING_TEST_CASE_IN_SUITE_CLASS

#define KRATOS_TESTING_TEST_CASE_IN_SUITE_CLASS (   TestCaseName,
  ParentName 
)
Value:
class KRATOS_TESTING_CREATE_CLASS_NAME(TestCaseName) : public ParentName { \
KRATOS_TESTING_TEST_CASE_CLASS_BODY(TestCaseName, ParentName) \
static const Kratos::Testing::Internals::AddThisTestToTestSuite \
mAnotherDummy; \
};

Typedef Documentation

◆ DenseMatrixPointerType

template<class TSparseSpace , class TDenseSpace >
typedef TDenseSpace::MatrixPointerType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::DenseMatrixPointerType

◆ DenseMatrixType

template<class TSparseSpace , class TDenseSpace >
typedef TDenseSpace::MatrixType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::DenseMatrixType

◆ DenseVectorPointerType

template<class TSparseSpace , class TDenseSpace >
typedef TDenseSpace::VectorPointerType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::DenseVectorPointerType

◆ DenseVectorType

template<class TSparseSpace , class TDenseSpace >
typedef TDenseSpace::VectorType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::DenseVectorType

◆ element_type

template<class TDataType >
using Kratos::GlobalPointer< TDataType >::element_type = TDataType

Definition of element type.

◆ HashType

using Kratos::HashType = typedef std::size_t

The definition of the hash type.

◆ IndexType

typedef std::size_t Kratos::IndexType

The definition of the index type.

Index definition.

The index type definition.

◆ MatrixPointerType

template<class TSparseSpace , class TDenseSpace >
typedef TSparseSpace::MatrixPointerType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::MatrixPointerType

◆ MatrixType

template<class TSparseSpace , class TDenseSpace >
typedef TSparseSpace::MatrixType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::MatrixType

◆ VectorPointerType

template<class TSparseSpace , class TDenseSpace >
typedef TSparseSpace::VectorPointerType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::VectorPointerType

◆ VectorType

template<class TSparseSpace , class TDenseSpace >
typedef TSparseSpace::VectorType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::VectorType

Function Documentation

◆ AddColumn()

void Kratos::TableStream::AddColumn ( const std::string &  HeaderName,
const int  ColumnWidth 
)
inline

Add a column to our table.

Parameters
HeaderNameName to be print for the header
ColumnWidthThe width of the column must be at least 4 spaces

◆ Clear()

template<class TSparseSpace , class TDenseSpace >
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::Clear ( )
inlinevirtual

Clear the internal storage Clears all the internal data (e.g. previous observation matrices)

Reimplemented in Kratos::IBQNMVQNConvergenceAccelerator< TSparseSpace, TDenseSpace >.

◆ ComputeJacobianApproximation()

template<class TSparseSpace , class TDenseSpace >
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::ComputeJacobianApproximation ( )
inlineprotectedvirtual

◆ ConvergenceAccelerator() [1/3]

template<class TSparseSpace , class TDenseSpace >
Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::ConvergenceAccelerator ( )
default

◆ ConvergenceAccelerator() [2/3]

template<class TSparseSpace , class TDenseSpace >
Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::ConvergenceAccelerator ( const ConvergenceAccelerator< TSparseSpace, TDenseSpace > &  Other)
delete

◆ ConvergenceAccelerator() [3/3]

template<class TSparseSpace , class TDenseSpace >
Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::ConvergenceAccelerator ( Parameters  ThisParameters)
inline

◆ DistributedTestCase() [1/3]

Kratos::Testing::DistributedTestCase::DistributedTestCase ( )
delete

TestCase cannot be created without a name.

◆ DistributedTestCase() [2/3]

Kratos::Testing::DistributedTestCase::DistributedTestCase ( DistributedTestCase const &  rOther)
delete

The TestCase cannot be copied to avoid duplications.

◆ DistributedTestCase() [3/3]

Kratos::Testing::DistributedTestCase::DistributedTestCase ( std::string const &  Name)

The constructor to be called.

◆ Finalize()

template<class TSparseSpace , class TDenseSpace >
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::Finalize ( )
inlinevirtual

Finalize the convergence accelerator Perform all the operations required after the resolution of the problem.

Reimplemented in Kratos::IBQNMVQNConvergenceAccelerator< TSparseSpace, TDenseSpace >.

◆ FinalizeNonLinearIteration()

template<class TSparseSpace , class TDenseSpace >
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::FinalizeNonLinearIteration ( )
inlinevirtual

◆ FinalizeSolutionStep()

template<class TSparseSpace , class TDenseSpace >
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::FinalizeSolutionStep ( )
inlinevirtual

Operations after solving the solution step Performs all the required operations that should be done (for each step) after solving the solution step.

Reimplemented in Kratos::MVQNRandomizedSVDConvergenceAccelerator< TSparseSpace, TDenseSpace >, Kratos::MVQNFullJacobianConvergenceAccelerator< TSparseSpace, TDenseSpace >, and Kratos::IBQNMVQNConvergenceAccelerator< TSparseSpace, TDenseSpace >.

◆ get() [1/2]

template<class TDataType >
TDataType* Kratos::GlobalPointer< TDataType >::get ( )
inline

Get a non-const pointer to the data.

Returns
A pointer to the data.

◆ get() [2/2]

template<class TDataType >
TDataType const* Kratos::GlobalPointer< TDataType >::get ( ) const
inline

Get a const pointer to the data.

Returns
A const pointer to the data.

◆ GetEchoLevel()

template<class TSparseSpace , class TDenseSpace >
int Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::GetEchoLevel ( )
inline

Get the Echo Level object Get the echo level of the convergence accelerator.

Returns
int Echo level value

◆ GetInitialDeformationGradientMatrix()

const Matrix & Kratos::InitialState::GetInitialDeformationGradientMatrix ( ) const

This method returns the initial stress vector if was set before.

◆ GetInitialStrainVector()

const Vector & Kratos::InitialState::GetInitialStrainVector ( ) const

This method returns the initial strain vector if was set before.

◆ GetInitialStressVector()

const Vector & Kratos::InitialState::GetInitialStressVector ( ) const

This method returns the initial stress vector if was set before.

◆ GetNumColumns()

unsigned int Kratos::TableStream::GetNumColumns ( ) const
inline

It returns the number of columns.

Returns
The size of mColumnHeaders (the column headers)

◆ GetProblemSize()

template<class TSparseSpace , class TDenseSpace >
virtual std::size_t Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::GetProblemSize ( ) const
inlineprotectedvirtual

◆ GetRank()

template<class TDataType >
int Kratos::GlobalPointer< TDataType >::GetRank ( ) const
inline

Returns the rank of the global pointer.

Returns the rank of the global pointer data is located or 0 if no mpi

Returns
rank of the global pointer data or 0

◆ GetTableWidth()

unsigned int Kratos::TableStream::GetTableWidth ( ) const
inline

It returns the table width.

Returns
mTableWidth: The table width

◆ GlobalPointer() [1/9]

template<class TDataType >
Kratos::GlobalPointer< TDataType >::GlobalPointer ( )
inline

Default constructor.

This should never be called as we need a local pointer to exists

◆ GlobalPointer() [2/9]

template<class TDataType >
Kratos::GlobalPointer< TDataType >::GlobalPointer ( const GlobalPointer< TDataType > &&  rOther)
inline

Move constructor for GlobalPointer.

Parameters
rOtherThe GlobalPointer to move from.

◆ GlobalPointer() [3/9]

template<class TDataType >
Kratos::GlobalPointer< TDataType >::GlobalPointer ( const GlobalPointer< TDataType > &  rOther)
inline

Copy constructor for GlobalPointer.

Parameters
rOtherThe GlobalPointer to copy from.

◆ GlobalPointer() [4/9]

template<class TDataType >
Kratos::GlobalPointer< TDataType >::GlobalPointer ( Kratos::intrusive_ptr< TDataType > &  DataPointer,
int  Rank = 0 
)
inline

Constructor by Kratos::intrusive_ptr.

Parameters
DataPointerBoost intrusive Pointer to the Data.

◆ GlobalPointer() [5/9]

template<class TDataType >
Kratos::GlobalPointer< TDataType >::GlobalPointer ( Kratos::shared_ptr< TDataType >  DataPointer,
int  Rank = 0 
)
inline

Constructor by Kratos::shared_ptr.

Parameters
DataPointerStd Shared Pointer to the Data.

◆ GlobalPointer() [6/9]

template<class TDataType >
Kratos::GlobalPointer< TDataType >::GlobalPointer ( Kratos::weak_ptr< TDataType >  DataPointer,
int  Rank = 0 
)
inline

Constructor by Kratos::weak_ptr.

Parameters
DataPointerKratos Weak Pointer to the Data.

◆ GlobalPointer() [7/9]

template<class TDataType >
Kratos::GlobalPointer< TDataType >::GlobalPointer ( std::unique_ptr< TDataType >  DataPointer,
int  Rank = 0 
)
delete

Constructor by std::unique_ptr.

Parameters
DataPointerStd Unique Pointer to the Data.

◆ GlobalPointer() [8/9]

template<class TDataType >
Kratos::GlobalPointer< TDataType >::GlobalPointer ( TDataType *  DataPointer,
int  Rank = 0 
)
inline

Constructor by DataPointer.

Parameters
DataPointerPointer to the data.

◆ GlobalPointer() [9/9]

template<class TDataType >
Kratos::GlobalPointer< TDataType >::GlobalPointer ( TDataType  Data)
delete

Constructor by Data.

Parameters
Datathe data.

◆ HashCombine()

template<class TClassType >
void Kratos::HashCombine ( HashType Seed,
const TClassType &  Value 
)
inline

This method creates an "unique" hash for the input value.

It comes from boost, taken from here: https://www.boost.org/doc/libs/1_55_0/doc/html/hash/reference.html#boost.hash_combine

Template Parameters
TClassTypeThe type of class to be hashed
Parameters
SeedThis is the seed used to create the hash
ValueThis is the value to be hashed

◆ HashRange()

template<class TClassType >
HashType Kratos::HashRange ( TClassType  First,
TClassType  Last 
)
inline

This method combines hash until it reaches the last class in order to obtain a corresponding seed.

Template Parameters
TClassTypeThe type of class to be hashed
Parameters
FirstThe first class to be compared
LastThe last class to be compared
Returns
The resulting seed

◆ Info() [1/2]

template<class TDataType >
std::string Kratos::GlobalPointer< TDataType >::Info ( ) const
inline

Turn back information as a string.

◆ Info() [2/2]

std::string Kratos::Testing::DistributedTestCase::Info ( ) const
overridevirtual

Turn back information as a string.

Reimplemented from Kratos::Testing::TestCase.

◆ Initialize()

template<class TSparseSpace , class TDenseSpace >
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::Initialize ( )
inlinevirtual

◆ InitializeNonLinearIteration()

template<class TSparseSpace , class TDenseSpace >
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::InitializeNonLinearIteration ( )
inlinevirtual

Operations before each non-linear iteration Performs all the required operations that should be done before each non-linear iteration.

Reimplemented in Kratos::IBQNMVQNConvergenceAccelerator< TSparseSpace, TDenseSpace >.

◆ InitializeSolutionStep()

template<class TSparseSpace , class TDenseSpace >
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::InitializeSolutionStep ( )
inlinevirtual

◆ InitialState() [1/5]

Kratos::InitialState::InitialState ( const Matrix rInitialDeformationGradientMatrix)

◆ InitialState() [2/5]

Kratos::InitialState::InitialState ( const SizeType  Dimension)

Only defining Dimension constructor.

◆ InitialState() [3/5]

Kratos::InitialState::InitialState ( const Vector rImposingEntity,
const InitialImposingType  InitialImposition = InitialImposingType::STRAIN_ONLY 
)

◆ InitialState() [4/5]

Kratos::InitialState::InitialState ( const Vector rInitialStrainVector,
const Vector rInitialStressVector 
)

◆ InitialState() [5/5]

Kratos::InitialState::InitialState ( const Vector rInitialStrainVector,
const Vector rInitialStressVector,
const Matrix rInitialDeformationGradientMatrix 
)

◆ IsBlockNewton()

template<class TSparseSpace , class TDenseSpace >
virtual bool Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::IsBlockNewton ( ) const
inlinevirtual

Checks if the update direction is unique or double For the current convergence accelerator, this method returns information about the nature of the coupling If it is block Newton, the update is done in both directions. Otherwise, it is done in one direction.

Returns
true If the convergence accelerator updates in both directions (e.g. displacements and tractions)
false If the convergece accelerator updates in a single direction (e.g. only displacements)

Reimplemented in Kratos::IBQNMVQNConvergenceAccelerator< TSparseSpace, TDenseSpace >.

◆ IsDisabled()

bool Kratos::Testing::DistributedTestCase::IsDisabled ( ) const
overridevirtual

Reimplemented from Kratos::Testing::TestCase.

◆ IsDistributedTest()

bool Kratos::Testing::DistributedTestCase::IsDistributedTest ( ) const
overridevirtual

Reimplemented from Kratos::Testing::TestCase.

◆ IsEnabled()

bool Kratos::Testing::DistributedTestCase::IsEnabled ( ) const
overridevirtual

Reimplemented from Kratos::Testing::TestCase.

◆ KRATOS_CLASS_POINTER_DEFINITION() [1/2]

template<class TSparseSpace , class TDenseSpace >
Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::KRATOS_CLASS_POINTER_DEFINITION ( ConvergenceAccelerator< TSparseSpace, TDenseSpace >  )

◆ KRATOS_CLASS_POINTER_DEFINITION() [2/2]

Kratos::TableStream::KRATOS_CLASS_POINTER_DEFINITION ( TableStream  )

Pointer definition of TableStream.

◆ load()

template<class TDataType >
void Kratos::GlobalPointer< TDataType >::load ( char *  buffer)
inline

Restores the GlobalPoiter with the data from the buffer.

Parameters
bufferObject data buffer

◆ operator()() [1/22]

HashType Kratos::DofPointerHasher::operator() ( const Dof< double >::Pointer &  pDoF) const
inline

The () operator.

Parameters
pDoFThe DoF pointer

◆ operator()() [2/22]

bool Kratos::DofPointerComparor::operator() ( const Dof< double >::Pointer &  pDoF1,
const Dof< double >::Pointer &  pDoF2 
) const
inline

The () operator.

Parameters
pDoF1The first DoF pointer
pDoF2The second DoF pointer

◆ operator()() [3/22]

template<class TDataType >
std::size_t Kratos::GlobalPointerHasher< TDataType >::operator() ( const GlobalPointer< TDataType > &  pGp) const
inline

The () operator for hashing a GlobalPointer.

Parameters
pGpThe GlobalPointer to be hashed.
Returns
The hash value of the GlobalPointer.

◆ operator()() [4/22]

template<class TDataType >
bool Kratos::GlobalPointerComparor< TDataType >::operator() ( const GlobalPointer< TDataType > &  pGp1,
const GlobalPointer< TDataType > &  pGp2 
) const
inline

The () operator.

Parameters
pDoF1The first DoF pointer
pDoF2The second DoF pointer

◆ operator()() [5/22]

template<class TDataType >
bool Kratos::GlobalPointerCompare< TDataType >::operator() ( const GlobalPointer< TDataType > &  pGp1,
const GlobalPointer< TDataType > &  pGp2 
) const
inline

The () operator.

Parameters
pDoF1The first DoF pointer
pDoF2The second DoF pointer

◆ operator()() [6/22]

template<typename T1 , typename T2 >
size_t std::hash< std::pair< T1, T2 > >::operator() ( const std::pair< T1, T2 > &  p) const
inline

Calculates the hash value of a given pair of values in a way that combines the hash values of the individual elements.

Parameters
pthe pair of values to be hashed.
Returns
the resulting hash value.

◆ operator()() [7/22]

template<class TType1 , class TType2 >
HashType Kratos::PairHasher< TType1, TType2 >::operator() ( const std::pair< TType1, TType2 > &  rPair) const
inline

The () operator.

Parameters
rPairThe index pair to hash

◆ operator()() [8/22]

template<class TType1 , class TType2 >
bool Kratos::PairComparor< TType1, TType2 >::operator() ( const std::pair< TType1, TType2 > &  rPair1,
const std::pair< TType1, TType2 > &  rPair2 
) const
inline

The () operator.

Parameters
rIndexPair1The first index pair to hash
rIndexPair2The second index pair to hash

◆ operator()() [9/22]

template<class TClassType >
bool Kratos::KeyComparorRange< TClassType >::operator() ( const TClassType &  first,
const TClassType &  second 
) const
inline

This is the () operator.

Parameters
firstThe first class to be compared
secondThe second class to be compared

◆ operator()() [10/22]

template<class TClassType >
HashType Kratos::KeyHasherRange< TClassType >::operator() ( const TClassType &  rRange) const
inline

This is the () operator.

Parameters
rRangeThe shared pointer to be hashed
Returns
The corresponding hash

◆ operator()() [11/22]

template<class TIndexedObject >
bool Kratos::IndexedObjectComparator< TIndexedObject >::operator() ( const TIndexedObject &  rFirst,
const TIndexedObject &  rSecond 
) const
inline

This is the () operator.

Parameters
rFirstThe first class to be compared
rSecondThe second class to be compared

◆ operator()() [12/22]

template<class TIndexedObject >
HashType Kratos::IndexedObjectHasher< TIndexedObject >::operator() ( const TIndexedObject &  rIndexedObject) const
inline

This is the () operator.

Parameters
rIndexedObjectThe indexed object to be hashed
Returns
The corresponding hash

◆ operator()() [13/22]

template<class TpIndexedObject >
bool Kratos::IndexedObjectPointerComparator< TpIndexedObject >::operator() ( const TpIndexedObject  pFirst,
const TpIndexedObject  pSecond 
) const
inline

This is the () operator.

Parameters
pFirstThe first class to be compared
pSecondThe second class to be compared

◆ operator()() [14/22]

template<class TpIndexedObject >
HashType Kratos::IndexedObjectPointerHasher< TpIndexedObject >::operator() ( const TpIndexedObject  pIndexedObject) const
inline

This is the () operator.

Parameters
pIndexedObjectThe indexed object pointer to be hashed
Returns
The corresponding hash

◆ operator()() [15/22]

template<class TSharedPointer >
bool Kratos::SharedPointerComparator< TSharedPointer >::operator() ( const TSharedPointer &  first,
const TSharedPointer &  second 
) const
inline

This is the () operator.

Parameters
firstThe first class to be compared
secondThe second class to be compared

◆ operator()() [16/22]

template<class TSharedPointer >
HashType Kratos::SharedPointerHasher< TSharedPointer >::operator() ( const TSharedPointer &  pPointer) const
inline

This is the () operator.

Parameters
pPointerThe shared pointer to be hashed
Returns
The corresponding hash

◆ operator()() [17/22]

template<class TVectorIndex >
HashType Kratos::VectorIndexHasher< TVectorIndex >::operator() ( const TVectorIndex &  k) const
inline

This is the () operator.

Parameters
kThe vector of indexes to be hashed
Returns
The corresponding hash

◆ operator()() [18/22]

template<class TVectorIndex >
bool Kratos::VectorIndexComparor< TVectorIndex >::operator() ( const TVectorIndex &  lhs,
const TVectorIndex &  rhs 
) const
inline

This is the () operator.

Parameters
lhsThe first class to be compared
rhsThe second class to be compared

◆ operator()() [19/22]

bool Kratos::VariableComparator::operator() ( const VariableData rFirst,
const VariableData rSecond 
) const

This is the () operator.

Parameters
rFirstThe first class to be compared
rSecondThe second class to be compared

◆ operator()() [20/22]

HashType Kratos::VariableHasher::operator() ( const VariableData rVariable) const

This is the () operator.

Parameters
rVariableThe variable to be hashed
Returns
The corresponding hash

◆ operator()() [21/22]

bool Kratos::pVariableComparator::operator() ( const VariableData pFirst,
const VariableData pSecond 
) const

This is the () operator.

Parameters
pFirstThe first variable to be compared
pSecondThe second variable to be compared

◆ operator()() [22/22]

HashType Kratos::pVariableHasher::operator() ( const VariableData pVariable) const

This is the () operator.

Parameters
pVariableThe variable pointer to be hashed
Returns
The corresponding hash

◆ operator*() [1/2]

template<class TDataType >
TDataType& Kratos::GlobalPointer< TDataType >::operator* ( )
inline

Dereference operator for non-const GlobalPointer.

Returns
Reference to the data pointed to by GlobalPointer.

◆ operator*() [2/2]

template<class TDataType >
TDataType const& Kratos::GlobalPointer< TDataType >::operator* ( ) const
inline

Dereference operator for const GlobalPointer.

Returns
Const reference to the data pointed to by GlobalPointer.

◆ operator->() [1/2]

template<class TDataType >
TDataType* Kratos::GlobalPointer< TDataType >::operator-> ( )
inline

Arrow operator for non-const GlobalPointer.

Returns
Pointer to the data pointed to by GlobalPointer.

◆ operator->() [2/2]

template<class TDataType >
TDataType const* Kratos::GlobalPointer< TDataType >::operator-> ( ) const
inline

Arrow operator for const GlobalPointer.

Returns
Const pointer to the data pointed to by GlobalPointer.

◆ operator<<() [1/47]

bool Kratos::operator<< ( Chunk const &  rFirst,
Chunk const &  rSedond 
)
inline

◆ operator<<() [2/47]

TableStream& Kratos::TableStream::operator<< ( double  Input)
inline

This is the operator << just for doubles.

Parameters
InputThe double considered
Returns
The updated table stream

◆ operator<<() [3/47]

TableStream& Kratos::TableStream::operator<< ( float  Input)
inline

This is the operator << just for floats.

Parameters
InputThe float considered
Returns
The updated table stream

◆ operator<<() [4/47]

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

output stream function

◆ operator<<() [5/47]

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

output stream function

◆ operator<<() [6/47]

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

output stream function

◆ operator<<() [7/47]

template<class TLocalMatrixType , class TLocalVectorType , class TValueType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const CoordinateTransformationUtils< TLocalMatrixType, TLocalVectorType, TValueType > &  rThis 
)
inline

output stream function

◆ operator<<() [8/47]

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

output stream function

◆ operator<<() [9/47]

template<class TDataType , class TIndexType >
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const DistributedNumbering< TIndexType > &  rThis 
)
inline

output stream function

◆ operator<<() [10/47]

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

output stream function

◆ operator<<() [11/47]

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

output stream function

◆ operator<<() [12/47]

template<unsigned int TDim>
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const EdgeBasedDataStructure< TDim > &  rThis 
)
inline

output stream function

◆ operator<<() [13/47]

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

output stream function

◆ operator<<() [14/47]

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

output stream function

◆ operator<<() [15/47]

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

output stream function

◆ operator<<() [16/47]

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

output stream function

◆ operator<<() [17/47]

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

output stream function

◆ operator<<() [18/47]

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

output stream function

◆ operator<<() [19/47]

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

output stream function

◆ operator<<() [20/47]

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

output stream function

◆ operator<<() [21/47]

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

output stream function

◆ operator<<() [22/47]

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

output stream function

◆ operator<<() [23/47]

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

output stream function

◆ operator<<() [24/47]

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

output stream function

◆ operator<<() [25/47]

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

output stream function

◆ operator<<() [26/47]

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

output stream function

◆ operator<<() [27/47]

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

output stream function

◆ operator<<() [28/47]

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

output stream function

◆ operator<<() [29/47]

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

output stream function

◆ operator<<() [30/47]

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

output stream function

◆ operator<<() [31/47]

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

output stream function

◆ operator<<() [32/47]

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

output stream function

◆ operator<<() [33/47]

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

output stream function

◆ operator<<() [34/47]

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

output stream function

◆ operator<<() [35/47]

template<class TIndexType = std::size_t>
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SparseContiguousRowGraph< TIndexType > &  rThis 
)
inline

output stream function

◆ operator<<() [36/47]

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

output stream function

◆ operator<<() [37/47]

template<SizeType TDim>
std::ostream& Kratos::operator<< ( std::ostream &  rOStream,
const SubModelPartSkinDetectionProcess< TDim > &  rThis 
)
inline

output stream function

◆ operator<<() [38/47]

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

output stream function

◆ operator<<() [39/47]

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

output stream function

◆ operator<<() [40/47]

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

output stream function

◆ operator<<() [41/47]

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

output stream function

◆ operator<<() [42/47]

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

output stream function

◆ operator<<() [43/47]

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

output stream function

◆ operator<<() [44/47]

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

output stream function

◆ operator<<() [45/47]

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

output stream function

◆ operator<<() [46/47]

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

output stream function

◆ operator<<() [47/47]

template<typename TClass >
TableStream& Kratos::TableStream::operator<< ( TClass  Input)
inline

This is the operator << for any kind of input.

Parameters
InputThe input considered
Returns
The updated table stream

◆ operator=() [1/2]

template<class TDataType >
GlobalPointer& Kratos::GlobalPointer< TDataType >::operator= ( const GlobalPointer< TDataType > &  rOther)
inline

Assignment operator for GlobalPointer.

Parameters
rOtherThe GlobalPointer to assign from.
Returns
Reference to the assigned GlobalPointer.

◆ operator=() [2/2]

DistributedTestCase& Kratos::Testing::DistributedTestCase::operator= ( DistributedTestCase const &  rOther)
delete

Preventing the assignment of the tests.

◆ operator==()

template<class TDataType >
bool Kratos::GlobalPointer< TDataType >::operator== ( const GlobalPointer< TDataType > &  rOther)
inline

Overloads the '==' operator to compare two GlobalPointer objects of the same template type. Returns true if the underlying pointers are equal.

Parameters
rOtherThe GlobalPointer object to be compared.
Returns
true if the underlying pointers are equal, false otherwise.

◆ operator>>() [1/32]

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

input stream function

◆ operator>>() [2/32]

template<class TLocalMatrixType , class TLocalVectorType , class TValueType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
CoordinateTransformationUtils< TLocalMatrixType, TLocalVectorType, TValueType > &  rThis 
)
inline

input stream function

◆ operator>>() [3/32]

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

input stream function

◆ operator>>() [4/32]

template<class TDataType , class TIndexType >
std::istream& Kratos::operator>> ( std::istream &  rIStream,
DistributedNumbering< TIndexType > &  rThis 
)
inline

input stream function

◆ operator>>() [5/32]

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

input stream function

◆ operator>>() [6/32]

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

input stream function

◆ operator>>() [7/32]

template<unsigned int TDim>
std::istream& Kratos::operator>> ( std::istream &  rIStream,
EdgeBasedDataStructure< TDim > &  rThis 
)
inline

input stream function

◆ operator>>() [8/32]

template<std::size_t TDim>
std::istream& Kratos::operator>> ( std::istream &  rIStream,
EdgeBasedGradientRecoveryElement< TDim > &  rThis 
)
inline

input stream function

◆ operator>>() [9/32]

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

input stream function

◆ operator>>() [10/32]

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

input stream function

◆ operator>>() [11/32]

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

input stream function

◆ operator>>() [12/32]

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

input stream function

◆ operator>>() [13/32]

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

input stream function

◆ operator>>() [14/32]

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

input stream function

◆ operator>>() [15/32]

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

input stream function

◆ operator>>() [16/32]

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

input stream function

◆ operator>>() [17/32]

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

input stream function

◆ operator>>() [18/32]

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

input stream function

◆ operator>>() [19/32]

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

input stream function

◆ operator>>() [20/32]

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

input stream function

◆ operator>>() [21/32]

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

input stream function

◆ operator>>() [22/32]

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

input stream function

◆ operator>>() [23/32]

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

input stream function

◆ operator>>() [24/32]

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

input stream function

◆ operator>>() [25/32]

template<class TIndexType = std::size_t>
std::istream& Kratos::operator>> ( std::istream &  rIStream,
SparseContiguousRowGraph< TIndexType > &  rThis 
)
inline

input stream function

◆ operator>>() [26/32]

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

input stream function

◆ operator>>() [27/32]

template<SizeType TDim>
std::istream& Kratos::operator>> ( std::istream &  rIStream,
SubModelPartSkinDetectionProcess< TDim > &  rThis 
)
inline

input stream function

◆ operator>>() [28/32]

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

input stream function

◆ operator>>() [29/32]

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

input stream function

◆ operator>>() [30/32]

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

input stream function

◆ operator>>() [31/32]

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

input stream function

◆ operator>>() [32/32]

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

input stream function

◆ pGetInverseJacobianApproximation()

template<class TSparseSpace , class TDenseSpace >
virtual DenseMatrixPointerType Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::pGetInverseJacobianApproximation ( )
inlineprotectedvirtual

◆ PrintData()

template<class TDataType >
void Kratos::GlobalPointer< TDataType >::PrintData ( std::ostream &  rOStream) const
inline

Print object's data.

◆ PrintFooter()

void Kratos::TableStream::PrintFooter ( )
inline

This function prints the footer of the stream.

◆ PrintHeader()

void Kratos::TableStream::PrintHeader ( )
inline

This function prints the header of the stream.

◆ PrintInfo()

template<class TDataType >
void Kratos::GlobalPointer< TDataType >::PrintInfo ( std::ostream &  rOStream) const
inline

Print information about this object.

◆ Profile()

void Kratos::Testing::DistributedTestCase::Profile ( )
overridevirtual

Reimplemented from Kratos::Testing::TestCase.

◆ Run()

void Kratos::Testing::DistributedTestCase::Run ( )
overridevirtual

Reimplemented from Kratos::Testing::TestCase.

◆ save()

template<class TDataType >
void Kratos::GlobalPointer< TDataType >::save ( char *  buffer) const
inline

Fills buffer with the GlobalPoiter data.

Parameters
bufferObject data buffer

◆ SetBold()

void Kratos::TableStream::SetBold ( const bool UseBoldFont)
inline

Set if the bold fonts are used for the table.

◆ SetEchoLevel()

template<class TSparseSpace , class TDenseSpace >
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::SetEchoLevel ( int  Level)
inlinevirtual

Set the Echo Level object Set the echo level of the convergence accelerator.

Parameters
LevelEcho level value

◆ SetFlushLeft()

void Kratos::TableStream::SetFlushLeft ( )
inline

Set the flush orientation to the left.

◆ SetFlushRight()

void Kratos::TableStream::SetFlushRight ( )
inline

Set the flush orientation to the right.

◆ SetInitialDeformationGradientMatrix()

void Kratos::InitialState::SetInitialDeformationGradientMatrix ( const Matrix rInitialDeformationGradientMatrix)

This method sets the initial deformation gradient matrix.

Parameters
rInitialDeformationGradientMatrixThe vector to be set

◆ SetInitialStrainVector()

void Kratos::InitialState::SetInitialStrainVector ( const Vector rInitialStrainVector)

This method sets the initial strain vector.

Parameters
rInitialStrainVectorThe vector to be set

◆ SetInitialStressVector()

void Kratos::InitialState::SetInitialStressVector ( const Vector rInitialStressVector)

This method sets the initial stress vector.

Parameters
rInitialStressVectorThe vector to be set

◆ SetRank()

template<class TDataType >
void Kratos::GlobalPointer< TDataType >::SetRank ( const int  Rank)
inline

Sets the rank of the global pointer.

Sets the rank of the global pointer where data is located

Parameters
RankThe rank to set

◆ SetSeparator()

void Kratos::TableStream::SetSeparator ( const std::string &  Separator)
inline

Set the separator used for the table.

◆ TableStream()

Kratos::TableStream::TableStream ( std::ostream *  Output,
const std::string &  Separator = "|",
const bool  UseBoldFont = true 
)
inline

Default constructor.

◆ UpdateSolution()

template<class TSparseSpace , class TDenseSpace >
virtual void Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::UpdateSolution ( const VectorType rResidualVector,
VectorType rIterationGuess 
)
inlinevirtual

Corrects the given iteration guess Computes the correction of the iteration guess according to the provided residual vector Note that the correction is performed over the given iteration guess, so the return value is already modified.

Parameters
rResidualVectorResidual vector from which the correction is computed
rIterationGuessIteration guess to be corrected

Reimplemented in Kratos::TrilinosMVQNRecursiveJacobianConvergenceAccelerator< TSparseSpace, TDenseSpace >, Kratos::MVQNRecursiveJacobianConvergenceAccelerator< TSparseSpace, TDenseSpace >, Kratos::MVQNFullJacobianConvergenceAccelerator< TSparseSpace, TDenseSpace >, Kratos::IBQNMVQNConvergenceAccelerator< TSparseSpace, TDenseSpace >, Kratos::ConstantRelaxationConvergenceAccelerator< TSparseSpace, TDenseSpace >, and Kratos::AitkenConvergenceAccelerator< TSparseSpace, TDenseSpace >.

◆ ~ConvergenceAccelerator()

template<class TSparseSpace , class TDenseSpace >
virtual Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::~ConvergenceAccelerator ( )
virtualdefault

◆ ~DistributedTestCase()

Kratos::Testing::DistributedTestCase::~DistributedTestCase ( )
override

Destructor.

◆ ~GlobalPointer()

template<class TDataType >
Kratos::GlobalPointer< TDataType >::~GlobalPointer ( )
default

Destructor.

◆ ~TableStream()

virtual Kratos::TableStream::~TableStream ( )
virtualdefault

Destructor.

Variable Documentation

◆ mEchoLevel

template<class TSparseSpace , class TDenseSpace >
int Kratos::ConvergenceAccelerator< TSparseSpace, TDenseSpace >::mEchoLevel
protected

Friends

◆ Serializer [1/2]

template<class TDataType >
friend class Serializer
friend

Friend class Serializer for handling serialization.

◆ Serializer [2/2]

friend class Serializer
friend