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

Namespaces

 CoSimIO_Wrappers
 
 Detail
 
 detail
 
 EMPIRE_API_Wrappers
 

Classes

struct  Array1DModifier
 
class  ControllerTrampoline
 
class  PyAdjointResponseFunction
 
class  ContainerInterface
 
class  MapInterface
 
class  PointerVectorPythonInterface
 
class  PointerVectorSetPythonInterface
 
class  VariableIndexingPython
 Short class definition. More...
 
class  VertexContainerIOTrampoline
 
class  PointLocatorAdaptorTrampoline
 
class  VariableChecker
 

Typedefs

using BoundingBoxType = BoundingBox< Point >
 
using NodesContainerType = ModelPart::NodesContainerType
 
using SizeType = std::size_t
 
using ConstitutiveLawBaseType = ConstitutiveLaw
 
using SpaceType = UblasSpace< double, CompressedMatrix, boost::numeric::ublas::vector< double > >
 
using LocalSpaceType = UblasSpace< double, Matrix, Vector >
 
using LinearSolverType = LinearSolver< SpaceType, LocalSpaceType >
 
using ComplexSpaceType = TUblasSparseSpace< std::complex< double > >
 
using ComplexLocalSpaceType = TUblasDenseSpace< std::complex< double > >
 
using LinearSolverFactoryType = LinearSolverFactory< SpaceType, LocalSpaceType >
 
using ComplexLinearSolverFactoryType = LinearSolverFactory< ComplexSpaceType, ComplexLocalSpaceType >
 
using PreconditionerFactoryType = PreconditionerFactory< SpaceType, LocalSpaceType >
 
using ExplicitBuilderType = ExplicitBuilder< SpaceType, LocalSpaceType >
 
using ExplicitBuilderFactoryType = Factory< ExplicitBuilderType >
 
using IndexType = std::size_t
 
using NodeType = Node
 
using NodeContainerType = PointerVector< NodeType >
 
using GeometryType = Geometry< NodeType >
 
using PointsArrayType = typename GeometryType::PointsArrayType
 
using IntegrationPointsArrayType = typename GeometryType::IntegrationPointsArrayType
 
using GeometriesArrayType = typename GeometryType::GeometriesArrayType
 
using CoordinatesArrayType = typename Point::CoordinatesArrayType
 
template<class TDataType >
using TSpaceType = UblasSpace< TDataType, boost::numeric::ublas::compressed_matrix< TDataType >, boost::numeric::ublas::vector< TDataType > >
 
template<class TDataType >
using TLocalSpaceType = UblasSpace< TDataType, DenseMatrix< TDataType >, DenseVector< TDataType > >
 
template<class TDataType , class TOtherDataType >
using TLinearSolverType = LinearSolver< TSpaceType< TDataType >, TLocalSpaceType< TOtherDataType > >
 
template<class TDataType >
using TDirectSolverType = DirectSolver< TUblasSparseSpace< TDataType >, TUblasDenseSpace< TDataType > >
 
using MeshType = Mesh< Node, Properties, Element, Condition >
 
typedef GeometryType::PointsArrayType NodesArrayType
 
using SparseSpaceType = UblasSpace< double, CompressedMatrix, Vector >
 
using PropertiesContainerType = PointerVectorSet< Properties, IndexedObject >
 
typedef UblasSpace< std::complex< double >, ComplexCompressedMatrix, boost::numeric::ublas::vector< std::complex< double > > > ComplexSparseSpaceType
 
typedef Table< double, doubleDoubleTableType
 
template<class TDataType >
using ContiguousNumpyArray = pybind11::array_t< TDataType, pybind11::array::c_style >
 
typedef ConstitutiveLaw::Pointer ConstitutiveLawPointer
 
typedef std::vector< ConstitutiveLaw::Pointer > MaterialsContainer
 
typedef ConstitutiveModel ConstitutiveModelBaseType
 
typedef ConstitutiveModel::Pointer ConstitutiveModelPointer
 
typedef FrictionLaw::Pointer FrictionLawPointerType
 
using DataLocation = Globals::DataLocation
 
typedef SpatialBoundingBox::Pointer BoundingBoxPointer
 
typedef std::vector< SpatialBoundingBox::Pointer > BoundingBoxContainer
 
typedef Process::Pointer ProcessPointer
 
typedef MesherProcess::Pointer MesherProcessPointer
 
typedef std::vector< MesherProcessPointerMesherProcessContainer
 
typedef std::vector< FlagsFlagsContainer
 
typedef ModelPart::NodesContainerType::iterator PointIterator
 
typedef std::vector< array_1d< double, 3 > > ComponentVectorType
 
typedef std::vector< array_1d< double, 3 > >::iterator ComponentIteratorType
 
typedef TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector > TrilinosSparseSpaceType
 
typedef UblasSpace< double, Matrix, VectorUblasLocalSpaceType
 
typedef LinearSolver< TrilinosSparseSpaceType, UblasLocalSpaceTypeTrilinosLinearSolverType
 
template<unsigned int TDim>
using TrilinosDistanceSmoothingProcess = DistanceSmoothingProcess< TDim, TrilinosSparseSpaceType, UblasLocalSpaceType, TrilinosLinearSolverType >
 
typedef ParticleFlowRule::Pointer MPMFlowRulePointer
 
typedef ParticleYieldCriterion::Pointer MPMYieldCriterionPointer
 
typedef ParticleHardeningLaw::Pointer MPMHardeningLawPointer
 
typedef Properties::Pointer PropertiesPointer
 
typedef Condition ConditionBaseType
 
typedef ModelPart::ElementsContainerType ElementsContainerType
 
typedef ModelPart::ConditionsContainerType ConditionsContainerType
 
typedef SolutionStrategy< SparseSpaceType, LocalSpaceType, LinearSolverTypeSolutionStrategyType
 
typedef SolutionBuilderAndSolver< SparseSpaceType, LocalSpaceType, LinearSolverTypeSolutionBuilderAndSolverType
 
typedef SolutionScheme< SparseSpaceType, LocalSpaceTypeSolutionSchemeType
 
typedef ConvergenceCriterion< SparseSpaceType, LocalSpaceTypeConvergenceCriterionType
 
typedef SolutionStrategyType::Pointer SolutionStrategyPointer
 
typedef std::vector< SolutionStrategyType::Pointer > SolutionStrategiesContainer
 
typedef ConvergenceCriterionType::Pointer ConvergenceCriterionPointerType
 
typedef std::vector< ConvergenceCriterionPointerTypeConvergenceCriteriaContainer
 
typedef HydrodynamicInteractionLaw BaseHydrodynamicInteractionLawType
 
typedef BuoyancyLaw BaseBuoyancyLawType
 
typedef DragLaw BaseDragLawType
 
typedef InviscidForceLaw BaseInviscidForceLawType
 
typedef HistoryForceLaw BaseHistoryForceLaw
 
typedef VorticityInducedLiftLaw BaseVorticityInducedLiftLawType
 
typedef RotationInducedLiftLaw BaseRotationInducedLiftLawType
 
typedef SteadyViscousTorqueLaw BaseSteadyViscousTorqueLaw
 
typedef UblasSpace< double, Matrix, VectorTrilinosLocalSpaceType
 
typedef GidIO< PfemGidGaussPointsContainer, PfemGidMeshContainerGidIOType
 
typedef GidIO GidIOBaseType
 

Functions

void AddDistributedSparseMatricesToPython (pybind11::module &m)
 
void AddMPICommunicatorToPython (pybind11::module &m)
 
void AddMPIDataCommunicatorToPython (pybind11::module &m)
 
template<class TContainerType , class TVariableType >
void AddNonHistoricalVariableCheck (pybind11::module &m)
 
template<class TContainerType , typename... args>
void AddNonHistoricalVariableCheckFolder (pybind11::module &m)
 
template<class TContainerType >
void AddNonHistoricalVariableCheck (pybind11::module &m)
 
template<class TContainerType , class TVariableType >
void AddHistoricalVariableCheck (pybind11::module &m)
 
template<class TContainerType , typename... args>
void AddHistoricalVariableCheckFolder (pybind11::module &m)
 
template<class TContainerType >
void AddHistoricalVariableCheck (pybind11::module &m)
 
void AddMPIDebugUtilitiesToPython (pybind11::module &m)
 
void AddMPISearchStrategiesToPython (pybind11::module &m)
 
const DataCommunicatorCreateFromListOfRanks (const DataCommunicator &rReferenceComm, pybind11::list &rRanks, const std::string &rNewName)
 
void AddMPIUtilitiesToPython (pybind11::module &m)
 
void InitializeMPIParallelRun ()
 
 PYBIND11_MODULE (KratosMPI, m)
 
void AddAccessorsToPython (py::module &m)
 
void AddAccessorsToPython (pybind11::module &m)
 
void AddAMGCLSolverToPython (pybind11::module &m)
 
void AddBoundingBoxToPython (pybind11::module &m)
 
void AddCFDVariablesToPython (pybind11::module &m)
 
template<class TDataType >
bool CommunicatorSynchronizeVariable (Communicator &rCommunicator, Variable< TDataType > const &ThisVariable)
 
template<class TDataType >
bool CommunicatorSynchronizeNonHistoricalVariable (Communicator &rCommunicator, Variable< TDataType > const &ThisVariable)
 
template<class TDataType >
bool CommunicatorAssembleCurrentData (Communicator &rCommunicator, Variable< TDataType > const &ThisVariable)
 
template<class TDataType >
bool CommunicatorAssembleNonHistoricalData (Communicator &rCommunicator, Variable< TDataType > const &ThisVariable)
 
void AddCommunicatorToPython (pybind11::module &m)
 
template<class TVariableType >
bool ConstitutiveLawHas (ConstitutiveLaw &rThisConstitutiveLaw, TVariableType const &rThisVariable)
 
template<class TDataType >
const TDataType ConstitutiveLawGetValue (ConstitutiveLaw &rThisConstitutiveLaw, const Variable< TDataType > &rThisVariable, TDataType &value)
 
template<class TDataType >
const TDataType ConstitutiveLawCalculateValue (ConstitutiveLaw &rThisConstitutiveLaw, ConstitutiveLaw::Parameters &rValues, const Variable< TDataType > &rThisVariable, TDataType &value)
 
template<class TDataType >
void ConstitutiveLawSetValue (ConstitutiveLaw &rThisConstitutiveLaw, const Variable< TDataType > &rThisVariable, TDataType &value, const ProcessInfo &rCurrentProcessInfo)
 
void NewInterfaceCalculateMaterialResponse (ConstitutiveLaw &rThisConstitutiveLaw, ConstitutiveLaw::Parameters &rValues, const ConstitutiveLaw::StressMeasure &rStressMeasure)
 
Flags GetFeaturesOptions (ConstitutiveLaw::Features &rThisFeatures)
 
SizeType GetStrainSizeFeatures (ConstitutiveLaw::Features &rThisFeatures)
 
SizeType GetSpaceDimensionFeatures (ConstitutiveLaw::Features &rThisFeatures)
 
std::vector< ConstitutiveLaw::StrainMeasure > & GetStrainMeasuresFeatures (ConstitutiveLaw::Features &rThisFeatures)
 
Flags GetLawOptions (ConstitutiveLaw::Parameters &rThisParameters)
 
double GetDeterminantF1 (ConstitutiveLaw::Parameters &rThisParameters)
 
ConstitutiveLaw::StrainVectorTypeGetStrainVector1 (ConstitutiveLaw::Parameters &rThisParameters)
 
ConstitutiveLaw::StrainVectorTypeGetStrainVector2 (ConstitutiveLaw::Parameters &rThisParameters, ConstitutiveLaw::StrainVectorType &strain)
 
ConstitutiveLaw::StressVectorTypeGetStressVector1 (ConstitutiveLaw::Parameters &rThisParameters)
 
ConstitutiveLaw::StressVectorTypeGetStressVector2 (ConstitutiveLaw::Parameters &rThisParameters, ConstitutiveLaw::StressVectorType &stress)
 
ConstitutiveLaw::VoigtSizeMatrixTypeGetConstitutiveMatrix1 (ConstitutiveLaw::Parameters &rThisParameters)
 
ConstitutiveLaw::VoigtSizeMatrixTypeGetConstitutiveMatrix2 (ConstitutiveLaw::Parameters &rThisParameters, ConstitutiveLaw::VoigtSizeMatrixType &C)
 
const ConstitutiveLaw::DeformationGradientMatrixTypeGetDeformationGradientF1 (ConstitutiveLaw::Parameters &rThisParameters)
 
ConstitutiveLaw::DeformationGradientMatrixTypeGetDeformationGradientF2 (ConstitutiveLaw::Parameters &rThisParameters, ConstitutiveLaw::DeformationGradientMatrixType &F)
 
ConstitutiveLaw::Pointer CreateWithoutProperties (ConstitutiveLaw &rThisConstitutiveLaw, Kratos::Parameters NewParameters)
 
ConstitutiveLaw::Pointer CreateWithProperties (ConstitutiveLaw &rThisConstitutiveLaw, Kratos::Parameters NewParameters, const Properties &rProperties)
 
void AddConstitutiveLawToPython (pybind11::module &m)
 
template<class TVariableType >
bool HasHelperFunctionMasterSlaveConstraint (MasterSlaveConstraint &el, const TVariableType &rVar)
 
template<class TVariableType >
void SetValueHelperFunctionMasterSlaveConstraint (MasterSlaveConstraint &el, const TVariableType &rVar, const typename TVariableType::Type &Data)
 
template<class TVariableType >
TVariableType::Type GetValueHelperFunctionMasterSlaveConstraint (MasterSlaveConstraint &el, const TVariableType &rVar)
 
void AddConstraintToPython (pybind11::module &m)
 
template<class TContainerType >
void AddContainerExpressionToPython (pybind11::module &m, const std::string &rName)
 
template<class TContainerType >
void AddContainerExpressionUtilsToPython (pybind11::module &m, const std::string &rName)
 
void AddContainerExpressionToPython (pybind11::module &m)
 
Flags FlagsOr (const Flags &Left, const Flags &Right)
 
Flags FlagsAnd (const Flags &Left, const Flags &Right)
 
void FlagsSet1 (Flags &ThisFlag, const Flags &OtherFlag)
 
void FlagsSet2 (Flags &ThisFlag, const Flags &OtherFlag, bool Value)
 
template<class TBinderType , typename TContainerType , typename TVariableType >
void VariableIndexingUtility (TBinderType &binder)
 
template<class TBinderType , typename TContainerType , typename TVariableType >
void DataValueContainerIndexingUtility (TBinderType &binder)
 
void AddContainersToPython (pybind11::module &m)
 
void AddControllersToPython (pybind11::module &m)
 
void AddConvergenceAcceleratorsToPython (pybind11::module &m)
 
template<class TValue >
std::vector< TValue > VectorBroadcastWrapper (const DataCommunicator &rSelf, void(DataCommunicator::*pBroadcastMethod)(std::vector< TValue > &, const int) const, const std::vector< TValue > &rSourceValues, const int SourceRank)
 
template<class TModuleType , class TDataType >
void AddDataCommunicatorMethodForDataType (TModuleType &rDataCommunicatorModule)
 
void AddDataCommunicatorToPython (pybind11::module &m)
 
void AddDEMVariablesToPython (pybind11::module &m)
 
void AddDeprecatedVariablesToPython (pybind11::module &m)
 
void AddDofsToPython (pybind11::module &m)
 
void AddExpressionIOToPython (pybind11::module &rModule)
 
void AddFactoriesToPython (pybind11::module &m)
 
void AddFSIVariablesToPython (pybind11::module &m)
 
template<std::size_t TDim>
void InterpolateMeshVariableToSkinDouble (EmbeddedSkinUtility< TDim > &rEmbeddedSkinUtility, const Variable< double > &rVariable, const Variable< double > &rEmbeddedVariable)
 
template<std::size_t TDim>
void InterpolateMeshVariableToSkinArray (EmbeddedSkinUtility< TDim > &rEmbeddedSkinUtility, const Variable< array_1d< double, 3 >> &rVariable, const Variable< array_1d< double, 3 >> &rEmbeddedVariable)
 
template<std::size_t TDim>
void InterpolateDiscontinuousMeshVariableToSkinDouble (EmbeddedSkinUtility< TDim > &rEmbeddedSkinUtility, const Variable< double > &rVariable, const Variable< double > &rEmbeddedVariable, const std::string &rInterfaceSide)
 
template<std::size_t TDim>
void InterpolateDiscontinuousMeshVariableToSkinArray (EmbeddedSkinUtility< TDim > &rEmbeddedSkinUtility, const Variable< array_1d< double, 3 >> &rVariable, const Variable< array_1d< double, 3 >> &rEmbeddedVariable, const std::string &rInterfaceSide)
 
void AuxiliaryCalculateMLSShapeFunctions (const std::size_t Dim, const std::size_t Order, const Matrix &rPoints, const array_1d< double, 3 > &rX, const double h, Vector &rN)
 
void AuxiliaryCalculateMLSShapeFunctionsAndGradients (const std::size_t Dim, const std::size_t Order, const Matrix &rPoints, const array_1d< double, 3 > &rX, const double h, Vector &rN, Matrix &rDNDX)
 
void AddGeometricalUtilitiesToPython (pybind11::module &m)
 
const PointerVector< Node > & ConstGetPoints (GeometryType &geom)
 
PointerVector< Node > & GetPoints (GeometryType &geom)
 
void SetId1 (GeometryType &dummy, IndexType geometry_id)
 
void SetId2 (GeometryType &dummy, const std::string &geometry_name)
 
bool IsIdGeneratedFromString1 (GeometryType &dummy)
 
bool IsIdSelfAssigned1 (GeometryType &dummy)
 
void AddGeometriesToPython (pybind11::module &m)
 
void AddGlobalPointersToPython (pybind11::module &m)
 
void AddGlobalsToPython (pybind11::module &m)
 
void ReadInitialValues1 (IO &IO, IO::NodesContainerType &rThisNodes, IO::ElementsContainerType &rThisElements, IO::ConditionsContainerType &rThisConditions)
 
void ReadInitialValues2 (IO &IO, ModelPart &rThisModelPart)
 
void AddIOToPython (pybind11::module &m)
 
bool HasFlag (Kernel &rKernel, const std::string &flag_name)
 
Flags GetFlag (Kernel &rKernel, const std::string &flag_name)
 
template<class TVariableType >
bool HasVariable (Kernel &rKernel, const std::string &variable_name)
 
template<class TVariableType >
const TVariableType & GetVariable (Kernel &rKernel, const std::string &variable_name)
 
bool HasConstitutiveLaw (Kernel &rKernel, const std::string &constitutive_law_name)
 
const ConstitutiveLawGetConstitutiveLaw (Kernel &rKernel, const std::string &constitutive_law_name)
 
template<class TVariableType >
void PrintVariablesName (Kernel &rKernel)
 
template<class TVariableType >
std::string GetVariableNames (Kernel &rKernel)
 
void AddKernelToPython (pybind11::module &m)
 
void RegisterToPythonApplicationVariables (std::string ApplicationName)
 
void AddKratosApplicationToPython (pybind11::module &m)
 
pybind11::list items (Parameters const &self)
 
pybind11::list keys (Parameters const &self)
 
pybind11::list values (Parameters const &self)
 
template<class T >
void Append (Parameters &rParameters, const T &obj)
 
Parameters GetValue (Parameters &rParameters, const std::string &rEntry)
 
Parameters GetArrayItem (Parameters &rParameters, const std::size_t Index)
 
void AddKratosParametersToPython (pybind11::module &m)
 
void AddLinearSolversToPython (pybind11::module &m)
 
const DataCommunicatorgetDataCommunicator (pybind11::kwargs kwargs)
 
void printImpl (pybind11::args args, pybind11::kwargs kwargs, Logger::Severity severity, bool useKwargLabel, LoggerMessage::DistributedFilter filterOption)
 
bool isPrintingRank (pybind11::kwargs kwargs)
 
void printDefault (pybind11::args args, pybind11::kwargs kwargs)
 
void printInfo (pybind11::args args, pybind11::kwargs kwargs)
 
void printWarning (pybind11::args args, pybind11::kwargs kwargs)
 
void printDefaultOnAllRanks (pybind11::args args, pybind11::kwargs kwargs)
 
void printInfoOnAllRanks (pybind11::args args, pybind11::kwargs kwargs)
 
void printWarningOnAllRanks (pybind11::args args, pybind11::kwargs kwargs)
 
void AddLoggerToPython (pybind11::module &m)
 
void AddMapperToPython (pybind11::module &m)
 
template<class TSparseSpace , class TDenseSpace >
void AddMappingToPython (pybind11::module &m)
 
void AddMappingVariablesToPython (pybind11::module &m)
 
void AddMATVariablesToPython (pybind11::module &m)
 
void AddMatrixMarketInterfaceToPython (pybind11::module &m)
 
template<typename TMatrixType >
py::class_< TMatrixType > CreateMatrixInterface (pybind11::module &m, std::string Name)
 
void AddMatrixToPython (pybind11::module &m)
 
void AddMemoryInfoToPython (pybind11::module &m)
 
void AddALEVariablesToPython (pybind11::module &m)
 
template<class TContainerType , class TVariableType >
bool HasHelperFunction (TContainerType &el, const TVariableType &rVar)
 
template<class TContainerType , class TVariableType >
void SetValueHelperFunction (TContainerType &el, const TVariableType &rVar, const typename TVariableType::Type &Data)
 
template<class TContainerType , class TVariableType >
TVariableType::Type GetValueHelperFunction (TContainerType &el, const TVariableType &rVar)
 
Properties::Pointer GetPropertiesFromElement (Element &pelem)
 
void SetPropertiesFromElement (Element &pelem, Properties::Pointer pProperties)
 
Properties::Pointer GetPropertiesFromCondition (Condition &pcond)
 
void SetPropertiesFromCondition (Condition &pcond, Properties::Pointer pProperties)
 
template<class T >
const GeometryTypeGetGeometryFromObject (T &rObject)
 
NodeType::Pointer GetNodeFromElement (Element &dummy, unsigned int index)
 
py::list GetNodesFromElement (Element &dummy)
 
NodeType::Pointer GetNodeFromCondition (Condition &dummy, unsigned int index)
 
void ConditionCalculateLocalSystemStandard (Condition &dummy, Matrix &rLeftHandSideMatrix, Vector &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo)
 
py::list GetNodesFromCondition (Condition &dummy)
 
py::list GetIntegrationPointsFromElement (Element &dummy)
 
void AddNodeToPython (pybind11::module &m)
 
template<class TDataType >
void AddNodalSolutionStepVariable (ModelPart &rModelPart, Variable< TDataType > const &rThisVariable)
 
template<class TDataType >
bool HasNodalSolutionStepVariable (ModelPart &rModelPart, Variable< TDataType > const &rThisVariable)
 
void SetModelPartName (ModelPart &rModelPart, std::string const &NewName)
 
const std::string GetModelPartName (ModelPart const &rModelPart)
 
ProcessInfoGetProcessInfo (ModelPart &rModelPart)
 
void SetProcessInfo (ModelPart &rModelPart, ProcessInfo &NewProcessInfo)
 
ModelPart::MeshType::Pointer ModelPartGetMesh (ModelPart &rModelPart)
 
ModelPart::MeshType::Pointer ModelPartGetMesh2 (ModelPart &rModelPart, ModelPart::IndexType MeshIndex)
 
Node ::Pointer ModelPartCreateNewNode (ModelPart &rModelPart, int Id, double x, double y, double z)
 
Geometry< Node >::Pointer ModelPartCreateNewGeometry1 (ModelPart &rModelPart, const std::string &GeometryTypeName, std::vector< ModelPart::IndexType > &NodeIdList)
 
Geometry< Node >::Pointer ModelPartCreateNewGeometry2 (ModelPart &rModelPart, const std::string &GeometryTypeName, ModelPart::IndexType GeometryId, std::vector< ModelPart::IndexType > &NodeIdList)
 
Geometry< Node >::Pointer ModelPartCreateNewGeometry3 (ModelPart &rModelPart, const std::string &GeometryTypeName, const std::string &GeometryIdentifierName, std::vector< ModelPart::IndexType > &NodeIdList)
 
Geometry< Node >::Pointer ModelPartCreateNewGeometry4 (ModelPart &rModelPart, const std::string &GeometryTypeName, ModelPart::GeometryType::Pointer pGeometry)
 
Geometry< Node >::Pointer ModelPartCreateNewGeometry5 (ModelPart &rModelPart, const std::string &GeometryTypeName, ModelPart::IndexType GeometryId, ModelPart::GeometryType::Pointer pGeometry)
 
Geometry< Node >::Pointer ModelPartCreateNewGeometry6 (ModelPart &rModelPart, const std::string &GeometryTypeName, const std::string &GeometryIdentifierName, ModelPart::GeometryType::Pointer pGeometry)
 
Element::Pointer ModelPartCreateNewElement (ModelPart &rModelPart, const std::string ElementName, ModelPart::IndexType Id, std::vector< ModelPart::IndexType > &NodeIdList, ModelPart::PropertiesType::Pointer pProperties)
 
Condition::Pointer ModelPartCreateNewCondition (ModelPart &rModelPart, const std::string ConditionName, ModelPart::IndexType Id, std::vector< ModelPart::IndexType > &NodeIdList, ModelPart::PropertiesType::Pointer pProperties)
 
ModelPart::SizeType ModelPartNumberOfNodes1 (ModelPart &rModelPart)
 
ModelPart::NodesContainerType::Pointer ModelPartGetNodes1 (ModelPart &rModelPart)
 
ModelPart::NodesContainerType::Pointer ModelPartGetNodes2 (ModelPart &rModelPart, ModelPart::IndexType ThisIndex)
 
void ModelPartSetNodes1 (ModelPart &rModelPart, ModelPart::NodesContainerType::Pointer pOtherNodes)
 
void ModelPartSetNodes2 (ModelPart &rModelPart, ModelPart::NodesContainerType::Pointer pOtherNodes, ModelPart::IndexType ThisIndex)
 
bool ModelPartHasNode1 (ModelPart &rModelPart, ModelPart::IndexType NodeId)
 
bool ModelPartHasNode2 (ModelPart &rModelPart, ModelPart::IndexType NodeId, ModelPart::IndexType ThisIndex)
 
ModelPart::NodeType::Pointer ModelPartGetNode1 (ModelPart &rModelPart, ModelPart::IndexType NodeId)
 
ModelPart::NodeType::Pointer ModelPartGetNode2 (ModelPart &rModelPart, ModelPart::IndexType NodeId, ModelPart::IndexType ThisIndex)
 
void ModelPartRemoveNode1 (ModelPart &rModelPart, ModelPart::IndexType NodeId)
 
void ModelPartRemoveNode2 (ModelPart &rModelPart, ModelPart::IndexType NodeId, ModelPart::IndexType ThisIndex)
 
void ModelPartRemoveNode3 (ModelPart &rModelPart, ModelPart::NodeType::Pointer pThisNode)
 
void ModelPartRemoveNode4 (ModelPart &rModelPart, ModelPart::NodeType::Pointer pThisNode, ModelPart::IndexType ThisIndex)
 
void ModelPartRemoveNodeFromAllLevels1 (ModelPart &rModelPart, ModelPart::IndexType NodeId)
 
void ModelPartRemoveNodeFromAllLevels2 (ModelPart &rModelPart, ModelPart::IndexType NodeId, ModelPart::IndexType ThisIndex)
 
void ModelPartRemoveNodeFromAllLevels3 (ModelPart &rModelPart, ModelPart::NodeType::Pointer pThisNode)
 
void ModelPartRemoveNodeFromAllLevels4 (ModelPart &rModelPart, ModelPart::NodeType::Pointer pThisNode, ModelPart::IndexType ThisIndex)
 
void ModelPartRemoveNodesFromAllLevels (ModelPart &rModelPart, Flags identifier_flag)
 
ModelPart::PropertiesContainerType::Pointer ModelPartGetPropertiesContainer (ModelPart &rModelPart)
 
void ModelPartSetPropertiesContainer (ModelPart &rModelPart, ModelPart::PropertiesContainerType::Pointer pOtherProperties)
 
ModelPart::SizeType ModelPartNumberOfElements1 (ModelPart &rModelPart)
 
ModelPart::ElementsContainerType::Pointer ModelPartGetElements1 (ModelPart &rModelPart)
 
ModelPart::ElementsContainerType::Pointer ModelPartGetElements2 (ModelPart &rModelPart, ModelPart::IndexType ThisIndex)
 
void ModelPartSetElements1 (ModelPart &rModelPart, ModelPart::ElementsContainerType::Pointer pOtherElements)
 
void ModelPartSetElements2 (ModelPart &rModelPart, ModelPart::ElementsContainerType::Pointer pOtherElements, ModelPart::IndexType ThisIndex)
 
bool ModelPartHasElement1 (ModelPart &rModelPart, ModelPart::IndexType ElementId)
 
bool ModelPartHasElement2 (ModelPart &rModelPart, ModelPart::IndexType ElementId, ModelPart::IndexType ThisIndex)
 
ModelPart::ElementType::Pointer ModelPartGetElement1 (ModelPart &rModelPart, ModelPart::IndexType ElementId)
 
ModelPart::ElementType::Pointer ModelPartGetElement2 (ModelPart &rModelPart, ModelPart::IndexType ElementId, ModelPart::IndexType ThisIndex)
 
void ModelPartRemoveElement1 (ModelPart &rModelPart, ModelPart::IndexType ElementId)
 
void ModelPartRemoveElement2 (ModelPart &rModelPart, ModelPart::IndexType ElementId, ModelPart::IndexType ThisIndex)
 
void ModelPartRemoveElement3 (ModelPart &rModelPart, ModelPart::ElementType::Pointer pThisElement)
 
void ModelPartRemoveElement4 (ModelPart &rModelPart, ModelPart::ElementType::Pointer pThisElement, ModelPart::IndexType ThisIndex)
 
void ModelPartRemoveElementFromAllLevels1 (ModelPart &rModelPart, ModelPart::IndexType ElementId)
 
void ModelPartRemoveElementFromAllLevels2 (ModelPart &rModelPart, ModelPart::IndexType ElementId, ModelPart::IndexType ThisIndex)
 
void ModelPartRemoveElementFromAllLevels3 (ModelPart &rModelPart, ModelPart::ElementType::Pointer pThisElement)
 
void ModelPartRemoveElementFromAllLevels4 (ModelPart &rModelPart, ModelPart::ElementType::Pointer pThisElement, ModelPart::IndexType ThisIndex)
 
void ModelPartRemoveElementsFromAllLevels (ModelPart &rModelPart, Flags identifier_flag)
 
ModelPart::SizeType ModelPartNumberOfConditions1 (ModelPart &rModelPart)
 
ModelPart::ConditionsContainerType::Pointer ModelPartGetConditions1 (ModelPart &rModelPart)
 
ModelPart::ConditionsContainerType::Pointer ModelPartGetConditions2 (ModelPart &rModelPart, ModelPart::IndexType ThisIndex)
 
void ModelPartSetConditions1 (ModelPart &rModelPart, ModelPart::ConditionsContainerType::Pointer pOtherConditions)
 
void ModelPartSetConditions2 (ModelPart &rModelPart, ModelPart::ConditionsContainerType::Pointer pOtherConditions, ModelPart::IndexType ThisIndex)
 
void ModelPartAddCondition1 (ModelPart &rModelPart, Condition::Pointer newCondition)
 
void ModelPartAddCondition2 (ModelPart &rModelPart, Condition::Pointer newCondition, unsigned int ThisIndex)
 
bool ModelPartHasCondition1 (ModelPart &rModelPart, ModelPart::IndexType ConditionId)
 
bool ModelPartHasCondition2 (ModelPart &rModelPart, ModelPart::IndexType ConditionId, ModelPart::IndexType ThisIndex)
 
ModelPart::ConditionType::Pointer ModelPartGetCondition1 (ModelPart &rModelPart, ModelPart::IndexType ConditionId)
 
ModelPart::ConditionType::Pointer ModelPartGetCondition2 (ModelPart &rModelPart, ModelPart::IndexType ConditionId, ModelPart::IndexType ThisIndex)
 
void ModelPartRemoveCondition1 (ModelPart &rModelPart, ModelPart::IndexType ConditionId)
 
void ModelPartRemoveCondition2 (ModelPart &rModelPart, ModelPart::IndexType ConditionId, ModelPart::IndexType ThisIndex)
 
void ModelPartRemoveCondition3 (ModelPart &rModelPart, ModelPart::ConditionType::Pointer pThisCondition)
 
void ModelPartRemoveCondition4 (ModelPart &rModelPart, ModelPart::ConditionType::Pointer pThisCondition, ModelPart::IndexType ThisIndex)
 
void ModelPartRemoveConditionFromAllLevels1 (ModelPart &rModelPart, ModelPart::IndexType ConditionId)
 
void ModelPartRemoveConditionFromAllLevels2 (ModelPart &rModelPart, ModelPart::IndexType ConditionId, ModelPart::IndexType ThisIndex)
 
void ModelPartRemoveConditionFromAllLevels3 (ModelPart &rModelPart, ModelPart::ConditionType::Pointer pThisCondition)
 
void ModelPartRemoveConditionFromAllLevels4 (ModelPart &rModelPart, ModelPart::ConditionType::Pointer pThisCondition, ModelPart::IndexType ThisIndex)
 
void ModelPartRemoveConditionsFromAllLevels (ModelPart &rModelPart, Flags identifier_flag)
 
void ModelPartAddGeometry1 (ModelPart &rModelPart, ModelPart::GeometryType::Pointer pNewGeometry)
 
ModelPart::GeometryType::Pointer ModelPartGetGeometry1 (ModelPart &rModelPart, ModelPart::IndexType GeometryId)
 
ModelPart::GeometryType::Pointer ModelPartGetGeometry2 (ModelPart &rModelPart, const std::string &GeometryName)
 
bool ModelPartHasGeometry1 (ModelPart &rModelPart, ModelPart::IndexType GeometryId)
 
bool ModelPartHasGeometry2 (ModelPart &rModelPart, const std::string &GeometryName)
 
void ModelPartRemoveGeometry1 (ModelPart &rModelPart, ModelPart::IndexType GeometryId)
 
void ModelPartRemoveGeometry2 (ModelPart &rModelPart, const std::string &GeometryName)
 
void ModelPartRemoveGeometryFromAllLevels1 (ModelPart &rModelPart, ModelPart::IndexType GeometryId)
 
void ModelPartRemoveGeometryFromAllLevels2 (ModelPart &rModelPart, const std::string &GeometryName)
 
ModelPart::MasterSlaveConstraintType::Pointer CreateNewMasterSlaveConstraint1 (ModelPart &rModelPart, std::string ConstraintName, ModelPart::IndexType Id, ModelPart::DofsVectorType &rMasterDofsVector, ModelPart::DofsVectorType &rSlaveDofsVector, ModelPart::MatrixType RelationMatrix, ModelPart::VectorType ConstantVector)
 
ModelPart::MasterSlaveConstraintType::Pointer CreateNewMasterSlaveConstraint2 (ModelPart &rModelPart, std::string ConstraintName, ModelPart::IndexType Id, ModelPart::NodeType &rMasterNode, ModelPart::DoubleVariableType &rMasterVariable, ModelPart::NodeType &rSlaveNode, ModelPart::DoubleVariableType &rSlaveVariable, double Weight, double Constant)
 
void ModelPartAddMasterSlaveConstraint (ModelPart &rModelPart, ModelPart::MasterSlaveConstraintType::Pointer pMasterSlaveConstraint)
 
void AddMasterSlaveConstraintsByIds (ModelPart &rModelPart, std::vector< ModelPart::IndexType > &ConstraintIds)
 
const ModelPart::MasterSlaveConstraintContainerTypeModelPartGetMasterSlaveConstraints1 (ModelPart &rModelPart)
 
ModelPart::SizeType ModelPartNumberOfMasterSlaveConstraints1 (ModelPart &rModelPart)
 
ModelPart::MasterSlaveConstraintType::Pointer ModelPartGetMasterSlaveConstraint1 (ModelPart &rModelPart, ModelPart::IndexType MasterSlaveConstraintId)
 
void ModelPartRemoveMasterSlaveConstraint1 (ModelPart &rModelPart, ModelPart::IndexType MasterSlaveConstraintId)
 
void ModelPartRemoveMasterSlaveConstraint2 (ModelPart &rModelPart, ModelPart::MasterSlaveConstraintType &rOtherMasterSlaveConstraint)
 
void ModelPartRemoveMasterSlaveConstraintFromAllLevels1 (ModelPart &rModelPart, ModelPart::IndexType MasterSlaveConstraintId)
 
void ModelPartRemoveMasterSlaveConstraintFromAllLevels2 (ModelPart &rModelPart, ModelPart::MasterSlaveConstraintType &rMasterSlaveConstraint)
 
CommunicatorModelPartGetCommunicator (ModelPart &rModelPart)
 
void RemoveSubModelPart1 (ModelPart &rModelPart, std::string const &ThisSubModelPartName)
 
void RemoveSubModelPart2 (ModelPart &rModelPart, ModelPart &ThisSubModelPart)
 
void AddNode1 (ModelPart &rModelPart, ModelPart::NodeType::Pointer pNode)
 
void AddNode2 (ModelPart &rModelPart, ModelPart::NodeType::Pointer pNode, const ModelPart::IndexType MeshId)
 
void AddNodesByIds (ModelPart &rModelPart, std::vector< ModelPart::IndexType > &NodesIds)
 
void AddElement1 (ModelPart &rModelPart, Element::Pointer pElement)
 
void AddElement2 (ModelPart &rModelPart, Element::Pointer pElement, const ModelPart::IndexType MeshId)
 
void AddElementsByIds (ModelPart &rModelPart, std::vector< ModelPart::IndexType > &ElementsIds)
 
void AddConditionsByIds (ModelPart &rModelPart, std::vector< ModelPart::IndexType > &ConditionsIds)
 
const ModelPart::SubModelPartIterator GetSubModelPartBegin (ModelPart &rModelPart)
 
const ModelPart::SubModelPartIterator GetSubModelPartEnd (ModelPart &rModelPart)
 
template<class TContainerType >
const std::unordered_set< std::string > GetNonHistoricalVariablesNames (ModelPart &rModelPart, TContainerType &rContainer, bool doFullSearch=false)
 
void AddModelPartToPython (pybind11::module &m)
 
ModelPartModel_GetModelPart (Model &rModel, const std::string &rFullModelPartName)
 
void AddModelToPython (pybind11::module &m)
 
void GenerateMesh (Modeler &GM, ModelPart &model_part, const std::string &rElementName, const std::string &rConditionName)
 
void GeneratePartialModelPart (ConnectivityPreserveModeler &GM, ModelPart &origin_model_part, ModelPart &destination_model_part, const std::string &rName)
 
void AddModelerToPython (pybind11::module &m)
 
template<class TVariableType >
void NodeFix (Node &rThisNode, TVariableType const &rThisVariable)
 
template<class TVariableType >
void NodeFree (Node &rThisNode, TVariableType const &rThisVariable)
 
template<class TVariableType >
bool NodeIsFixed (Node &rThisNode, TVariableType const &rThisVariable)
 
template<class TVariableType >
bool NodeHasDofFor (Node &rThisNode, TVariableType const &rThisVariable)
 
template<class TVariableType >
void NodeAddDof (Node &rThisNode, TVariableType const &rThisVariable)
 
template<class TVariableType >
void NodeAddDofwithReaction (Node &rThisNode, TVariableType const &rThisVariable, TVariableType const &rReactionVariable)
 
template<class TVariableType >
bool NodeSolutionStepsDataHas (Node &rThisNode, const TVariableType &rThisVariable)
 
void PointSetX0 (Node &ThisPoint, double Value)
 
void PointSetY0 (Node &ThisPoint, double Value)
 
void PointSetZ0 (Node &ThisPoint, double Value)
 
double PointGetX0 (Node &ThisPoint)
 
double PointGetY0 (Node &ThisPoint)
 
double PointGetZ0 (Node &ThisPoint)
 
template<class TBinderType , typename TContainerType , typename TVariableType >
void IndexingUtility (TBinderType &binder)
 
void AddOperationsToPython (pybind11::module &m)
 
pybind11::list GetSortedListOfFileNameDataHelper (std::vector< FileNameDataCollector::FileNameData > &rFileNameDataList, const std::vector< std::string > &rSortingFlagsOrder)
 A thin wrapper for GetSortedListOfFileNameData. The reason for having the wrapper is to replace the original lambda implementation as it causes gcc 4.8 to generate bad code on Centos7 which leads to memory corruption. More...
 
void SetOnProcessInfo (typename TableStreamUtility::Pointer pTable, ProcessInfo &rCurrentProcessInfo)
 Sets the current table utility on the process info. More...
 
void PrintTimingInformation (Timer &rTimer)
 
void ComputeNodesTangentModelPartWithSlipVariable (ModelPart &rModelPart, const Variable< array_1d< double, 3 >> &rSlipVariable, const double SlipCoefficient, const bool SlipAlways)
 
void ComputeNodesTangentModelPartWithOutSlipVariable (ModelPart &rModelPart, const double SlipCoefficient, const bool SlipAlways)
 
void ComputeNodesTangentModelPartWithSlipVariableNotAlwaysSlip (ModelPart &rModelPart, const Variable< array_1d< double, 3 >> &rSlipVariable, const double SlipCoefficient)
 
void ComputeNodesTangentModelPartWithOutSlipVariableNotAlwaysSlip (ModelPart &rModelPart, const double SlipCoefficient)
 
void ComputeNodesTangentModelPartWithSlipVariableNotAlwaysSlipUnitary (ModelPart &rModelPart, const Variable< array_1d< double, 3 >> &rSlipVariable)
 
void ComputeNodesTangentModelPartWithOutSlipVariableNotAlwaysSlipUnitary (ModelPart &rModelPart)
 
std::string GetRegisteredNameElement (const Element &rElement)
 
std::string GetRegisteredNameCondition (const Condition &rCondition)
 
template<class TEntityType , class TContainerType >
void AddSubModelPartEntitiesBooleanOperationToPython (pybind11::module &m, std::string Name)
 
void AddOtherUtilitiesToPython (pybind11::module &m)
 
void AddParallelEnvironmentToPython (pybind11::module &m)
 
template<class TPointType >
void PointSetX (TPointType &ThisPoint, double Value)
 
template<class TPointType >
void PointSetY (TPointType &ThisPoint, double Value)
 
template<class TPointType >
void PointSetZ (TPointType &ThisPoint, double Value)
 
template<class TPointType >
double PointGetX (TPointType &ThisPoint)
 
template<class TPointType >
double PointGetY (TPointType &ThisPoint)
 
template<class TPointType >
double PointGetZ (TPointType &ThisPoint)
 
void AddPointsToPython (pybind11::module &m)
 
ProcessInfo::Pointer ProcessInfoGetPreviousSolutionStepInfo (ProcessInfo &rProcessInfo)
 
ProcessInfo::Pointer ProcessInfoGetPreviousTimeStepInfo (ProcessInfo &rProcessInfo)
 
void AddProcessInfoToPython (pybind11::module &m)
 
template<std::size_t TDim>
void CalculateDiscontinuousEmbeddedVariableFromSkinDouble (CalculateDiscontinuousDistanceToSkinProcess< TDim > &rDiscDistProcess, const Variable< double > &rVariable, const Variable< double > &rEmbeddedVariable)
 
template<std::size_t TDim>
void CalculateDiscontinuousEmbeddedVariableFromSkinArray (CalculateDiscontinuousDistanceToSkinProcess< TDim > &rDiscDistProcess, const Variable< array_1d< double, 3 >> &rVariable, const Variable< array_1d< double, 3 >> &rEmbeddedVariable)
 
template<std::size_t TDim>
void CalculateEmbeddedVariableFromSkinDouble (CalculateDistanceToSkinProcess< TDim > &rDistProcess, const Variable< double > &rVariable, const Variable< double > &rEmbeddedVariable)
 
template<std::size_t TDim>
void CalculateEmbeddedVariableFromSkinArray (CalculateDistanceToSkinProcess< TDim > &rDistProcess, const Variable< array_1d< double, 3 >> &rVariable, const Variable< array_1d< double, 3 >> &rEmbeddedVariable)
 
template<std::size_t TDim, std::size_t TNumNodes, class TVariableType , const SizeType TNumNodesMaster = TNumNodes>
void DefineSimpleMortarMapperProcess (pybind11::module &m, const std::string &className)
 
void AddProcessesToPython (pybind11::module &m)
 
template<class TContainerType , class TVariableType >
bool PropertiesHasHelperFunction (TContainerType &rProperties, const TVariableType &rVar)
 
template<class TContainerType , class TVariableType >
void SetValueHelperFunction1 (TContainerType &rProperties, const TVariableType &rVar, const typename TVariableType::Type &rData)
 
PropertiesContainerTypeGetSubPropertiesArray1 (Properties &rProperties)
 
PropertiesContainerType const & GetSubPropertiesArray2 (const Properties &rProperties)
 
bool HasSubProperties1 (Properties &rProperties, IndexType Index)
 
Properties::Pointer GetSubProperties1 (Properties &rProperties, IndexType Index)
 
void SetArrayValue (Properties &rProperties, const Variable< array_1d< double, 3 >> &rVar, const std::vector< double > &rData)
 
void SetVectorValue (Properties &rProperties, const Variable< Vector > &rVar, const std::vector< double > &rData)
 
template<class TContainerType , class TVariableType >
TVariableType::Type GetValueHelperFunction1 (TContainerType &rContainer, const TVariableType &rVar)
 
template<class TContainerType , class TVariableType >
void EraseHelperFunction1 (TContainerType &rContainer, const TVariableType &rVar)
 
template<class TContainerType , class XVariableType , class YVariableType >
void SetTableHelperFunction1 (TContainerType &rContainer, const XVariableType &XVar, const YVariableType &YVar, const typename Properties::TableType &rData)
 
template<class TContainerType , class XVariableType , class YVariableType >
Properties::TableTypeGetTableHelperFunction1 (TContainerType &rContainer, const XVariableType &XVar, const YVariableType &YVar)
 
template<class TContainerType , class XVariableType , class YVariableType >
bool HasTableHelperFunction1 (TContainerType &rContainer, const XVariableType &XVar, const YVariableType &YVar)
 
template<typename TVariableType >
void AddInterfaceToAccessorFold (pybind11::class_< Properties, Properties::Pointer, Properties::BaseType > &pyProperties)
 
template<typename... TArgs>
void AddInterfaceToAccessor (pybind11::class_< Properties, Properties::Pointer, Properties::BaseType > &pyProperties)
 
void AddPropertiesToPython (pybind11::module &m)
 
double QuaternionGetX (Quaternion< double > &ThisQuaternion)
 Sets the current table utility on the process info. More...
 
double QuaternionGetY (Quaternion< double > &ThisQuaternion)
 
double QuaternionGetZ (Quaternion< double > &ThisQuaternion)
 
double QuaternionGetW (Quaternion< double > &ThisQuaternion)
 
void QuaternionSetX (Quaternion< double > &ThisQuaternion, double Value)
 
void QuaternionSetY (Quaternion< double > &ThisQuaternion, double Value)
 
void QuaternionSetZ (Quaternion< double > &ThisQuaternion, double Value)
 
void QuaternionSetW (Quaternion< double > &ThisQuaternion, double Value)
 
void AddQuaternionToPython (pybind11::module &m)
 
void AddRegistryToPython (pybind11::module &m)
 
void AddResponseFunctionsToPython (pybind11::module &m)
 
template<class TClass >
void GenerateListFromVectorOfVector (pybind11::list &rList, const TClass &rVector)
 Generates a list of lists from a vector of vectors. More...
 
void CopyRadiusArrayToPython (const pybind11::list &rListOfRadius, SpatialSearch::RadiusArrayType &rRadiusArray)
 Copies a list of doubles to a radius array. More...
 
SpatialSearch::RadiusArrayType CopyRadiusArrayToPython (const pybind11::list &rListOfRadius)
 Copies a Python list of radius to a C++ radius array. More...
 
template<class TClass >
std::tuple< pybind11::list, pybind11::list > GenerateSpatialSearchSolutionTuple (const TClass &rResults, SpatialSearch::VectorDistanceType &rDistances)
 Generates a tuple of two python lists containing the elements and distances of a spatial search result. More...
 
template<SpatialContainer TSearchBackend>
void DefineSpecializedSpatialSearch (pybind11::module &m, const std::string &rClassName)
 Defines a specialized spatial search module in Pybind11. More...
 
void AddSearchStrategiesToPython (pybind11::module &m)
 
template<class TObjectType >
void SerializerSave (Serializer &rSerializer, std::string const &rName, TObjectType &rObject)
 
template<class TObjectType >
void SerializerLoad (Serializer &rSerializer, std::string const &rName, TObjectType &rObject)
 
template<class TObjectType >
void SerializerLoadFromBeginning (Serializer &rSerializer, std::string const &rName, TObjectType &rObject)
 
void SerializerPrint (Serializer &rSerializer)
 
void AddSerializerToPython (pybind11::module &m)
 
void AddSparseMatricesToPython (pybind11::module &m)
 
double Dot (SparseSpaceType &dummy, SparseSpaceType::VectorType &rX, SparseSpaceType::VectorType &rY)
 
template<typename TSpaceType >
void ScaleAndAdd (TSpaceType &dummy, const double A, const typename TSpaceType::VectorType &rX, const double B, typename TSpaceType::VectorType &rY)
 
template<typename TSpaceType >
void Mult (TSpaceType &dummy, typename TSpaceType::MatrixType &rA, typename TSpaceType::VectorType &rX, typename TSpaceType::VectorType &rY)
 
void TransposeMult (SparseSpaceType &dummy, SparseSpaceType::MatrixType &rA, SparseSpaceType::VectorType &rX, SparseSpaceType::VectorType &rY)
 
template<typename TSpaceType >
TSpaceType::IndexType Size (TSpaceType &dummy, typename TSpaceType::VectorType const &rV)
 
template<typename TSpaceType >
TSpaceType::IndexType Size1 (TSpaceType &dummy, typename TSpaceType::MatrixType const &rM)
 
template<typename TSpaceType >
TSpaceType::IndexType Size2 (TSpaceType &dummy, typename TSpaceType::MatrixType const &rM)
 
template<typename TSpaceType >
void ResizeMatrix (TSpaceType &dummy, typename TSpaceType::MatrixType &A, unsigned int i1, unsigned int i2)
 
template<typename TSpaceType >
void ResizeVector (TSpaceType &dummy, typename TSpaceType::VectorType &x, unsigned int i1)
 
template<typename TSpaceType >
void SetToZeroMatrix (TSpaceType &dummy, typename TSpaceType::MatrixType &A)
 
template<typename TSpaceType >
void SetToZeroVector (TSpaceType &dummy, typename TSpaceType::VectorType &x)
 
template<typename TSpaceType >
void ClearMatrix (TSpaceType &dummy, typename TSpaceType::MatrixPointerType &A)
 
template<typename TSpaceType >
void ClearVector (TSpaceType &dummy, typename TSpaceType::VectorPointerType &x)
 
double TwoNorm (SparseSpaceType &dummy, SparseSpaceType::VectorType &x)
 
template<typename TSpaceType >
void UnaliasedAdd (TSpaceType &dummy, typename TSpaceType::VectorType &x, const double A, const typename TSpaceType::VectorType &rY)
 
void MoveMesh (Scheme< SparseSpaceType, LocalSpaceType > &dummy, ModelPart::NodesContainerType &rNodes)
 
template<typename TSpaceType >
TSpaceType::MatrixPointerType CreateEmptyMatrixPointer (TSpaceType &dummy)
 
template<typename TSpaceType >
TSpaceType::VectorPointerType CreateEmptyVectorPointer (TSpaceType &dummy)
 
CompressedMatrixGetMatRef (Kratos::shared_ptr< CompressedMatrix > &dummy)
 
VectorGetVecRef (Kratos::shared_ptr< Vector > &dummy)
 
template<typename TSpaceType >
py::class_< TSpaceTypeCreateSpaceInterface (pybind11::module &m, std::string Name)
 
void AddStrategiesToPython (pybind11::module &m)
 
double TableGetNearestValue (DoubleTableType &ThisTable, double X)
 
void AddTableToPython (pybind11::module &m)
 
void ListOfAllTestCases ()
 
void AddTestingToPython (pybind11::module &m)
 
template<class TDataType >
void AddCopyModelPartFlaggedInterface (pybind11::class_< VariableUtils > &rPythonVariableUtils)
 
void VariableUtilsUpdateCurrentPosition (VariableUtils &rVariableUtils, const ModelPart::NodesContainerType &rNodes)
 
void VariableUtilsUpdateCurrentPositionWithVariable (VariableUtils &rVariableUtils, const ModelPart::NodesContainerType &rNodes, const VariableUtils::ArrayVarType &rUpdateVariable)
 
void VariableUtilsUpdateCurrentPositionWithVariableAndPosition (VariableUtils &rVariableUtils, const ModelPart::NodesContainerType &rNodes, const VariableUtils::ArrayVarType &rUpdateVariable, const IndexType BufferPosition)
 
template<class TVarType >
void VariableUtilsCopyModelPartNodalVar (VariableUtils &rVariableUtils, const TVarType &rVariable, const ModelPart &rOriginModelPart, ModelPart &rDestinationModelPart, const unsigned int BuffStep=0)
 
template<class TVarType >
void VariableUtilsCopyModelPartNodalVarWithDestination (VariableUtils &rVariableUtils, const TVarType &rVariable, const TVarType &rDestinationVariable, const ModelPart &rOriginModelPart, ModelPart &rDestinationModelPart, const unsigned int BuffStep=0)
 
template<class TVarType >
void CopyModelPartNodalVarToNonHistoricalVar (VariableUtils &rVariableUtils, const TVarType &rVariable, const ModelPart &rOriginModelPart, ModelPart &rDestinationModelPart, const unsigned int BuffStep=0)
 
template<class TVarType >
void CopyModelPartNodalVarToNonHistoricalVarWithDestination (VariableUtils &rVariableUtils, const TVarType &rVariable, const TVarType &rDestinationVariable, const ModelPart &rOriginModelPart, ModelPart &rDestinationModelPart, const unsigned int BuffStep=0)
 
template<class TVarType >
void ApplyFixity (VariableUtils &rVariableUtils, const TVarType &rVar, const bool IsFixed, ModelPart::NodesContainerType &rNodes)
 
template<class TVarType >
void ApplyFlaggedFixity (VariableUtils &rVariableUtils, const TVarType &rVar, const bool IsFixed, ModelPart::NodesContainerType &rNodes, const Flags &rFlag, const bool CheckValue)
 
template<class TDataType , class TVarType = Variable<TDataType>>
void VariableUtilsSetVariable (VariableUtils &rVariableUtils, const TVarType &rVariable, const TDataType &rValue, ModelPart::NodesContainerType &rNodes)
 Auxiliary set variable export function This function is required to export the SetVariable overloaded method with a unique name. More...
 
template<class TDataType , class TVarType = Variable<TDataType>>
void VariableUtilsSetVariableForFlag (VariableUtils &rVariableUtils, const TVarType &rVariable, const TDataType &rValue, ModelPart::NodesContainerType &rNodes, const Flags Flag, const bool CheckValue=true)
 Auxiliary set variable export function This function is required to export the SetVariable with flag overloaded method with a unique name. More...
 
template<class TDataType , class TContainerType , class TVarType = Variable<TDataType>>
void VariableUtilsSetNonHistoricalVariable (VariableUtils &rVariableUtils, const TVarType &rVariable, const TDataType &rValue, TContainerType &rContainer)
 
template<class TDataType , class TContainerType , class TVarType = Variable<TDataType>>
void VariableUtilsSetNonHistoricalVariableForFlag (VariableUtils &rVariableUtils, const TVarType &rVariable, const TDataType &rValue, TContainerType &rContainer, const Flags Flag, const bool CheckValue=true)
 
void AddVariableUtilsToPython (pybind11::module &m)
 
template<typename TVectorType >
py::class_< TVectorType > CreateVectorInterface (pybind11::module &m, std::string Name)
 
template<std::size_t TSize>
void CreateArray1DInterface (pybind11::module &m, const std::string &Name)
 
void AddVectorToPython (pybind11::module &m)
 
std::string Hello ()
 
 PYBIND11_MODULE (Kratos, m)
 
template<class TDataType >
pybind11::array_t< TDataType > AllocateNumpyArray (const std::size_t NumberOfEntities, const std::vector< std::size_t > &rShape)
 
template<class TDataType >
pybind11::array_t< TDataType > MakeNumpyArray (TDataType const *pBegin, TDataType const *pEnd, const std::vector< std::size_t > &rShape)
 
void AddCustomProcessesToPython (pybind11::module &m)
 
void AddCustomStrategiesToPython (pybind11::module &m)
 
void AddCustomUtilitiesToPython (pybind11::module &m)
 
void TransferSolutionStepData (ModelPart &rFromModelPart, ModelPart &rToModelPart)
 
void AddCustomOperationsToPython (pybind11::module &m)
 
void AddCustomResponseFunctionUtilitiesToPython (pybind11::module &m)
 
void AddCustomConstitutiveLawsToPython (pybind11::module &m)
 
void AddCustomBoundingToPython (pybind11::module &m)
 
void AddCustomFrictionLawsToPython (pybind11::module &m)
 
void AddCustomMeshersToPython (pybind11::module &m)
 
template<std::size_t TDim, std::size_t TNumNodes, bool TNormalVariation, std::size_t TNumNodesMaster>
void RegisterFrictionalLaws (py::module &m, const std::string &rEndName)
 Registers frictional laws in the given module. More...
 
void AddCustomFrictionalLawsToPython (pybind11::module &m)
 
void AddCustomLinearSolversToPython (pybind11::module &m)
 
template<class TClass >
void RegisterContactSearchProcess (py::module &m, const std::string &rName)
 RegisterContactSearchProcess is a function that registers a contact search process in the given py::module object. More...
 
template<std::size_t TDim, std::size_t TNumNodes, std::size_t TNumNodesMaster>
void RegisterSimpleContactSearchProcess (py::module &m, const std::string &rEndName)
 Registers simple contact search process. More...
 
template<std::size_t TDim, std::size_t TNumNodes, std::size_t TNumNodesMaster>
void RegisterAdvancedContactSearchProcess (py::module &m, const std::string &rEndName)
 Registers advanced contact search process. More...
 
template<std::size_t TDim, std::size_t TNumNodes, std::size_t TNumNodesMaster>
void RegisterNormalGapProcess (py::module &m, const std::string &rEndName)
 Registers the normal gap process. More...
 
template<std::size_t TDim, std::size_t TNumNodes, std::size_t TNumNodesMaster>
void RegisterMPCContactSearchProcess (py::module &m, const std::string &rEndName)
 Registers MPC contact search process. More...
 
void AddCustomResponseFunctionsToPython (pybind11::module &m)
 
void GenerateModelPart (FaceHeatUtilities &FaceHeatUtilities, ModelPart &origin_model_part, ModelPart &destination_model_part, unsigned int domain_size)
 
template<unsigned int TDim>
void MountBin1 (MoveParticleUtilityScalarTransport< TDim > &rMoveParticleUtility)
 
template<unsigned int TDim>
void MountBin2 (MoveParticleUtilityScalarTransport< TDim > &rMoveParticleUtility, const double CellSize)
 
void AddCoSimIOToPython (pybind11::module &m)
 
void AddCustomIOToPython (pybind11::module &m)
 
 PYBIND11_MODULE (KratosCoSimulationMPIExtension, m)
 
void AddCustomMPIStrategiesToPython (pybind11::module &m)
 
void AssignTimeActivation (ConstructionUtility &rThisUtil, std::string ThermalSubModelPartName, int phase, double time_activation, double initial_temperature)
 
void InitializeSolutionStep (ConstructionUtility &rThisUtil, std::string ThermalSubModelPartName, std::string MechanicalSubModelPartName, std::string HeatFluxSubModelPartName, std::string HydraulicPressureSubModelPartName, bool thermal_conditions, bool mechanical_conditions, int phase)
 
void ActiveHeatFluxNoorzai (ConstructionUtility &rThisUtil, Parameters &NoorzaiParameters)
 
void ActiveHeatFluxAzenha (ConstructionUtility &rThisUtil, Parameters &AzenhaParameters)
 
void Push_Back_Bounding_Box (BoundingBoxContainer &ThisBoundingBoxContainer, BoundingBoxPointer ThisBoundingBox)
 
void Push_Back_Process (MesherProcessContainer &ThisProcessContainer, MesherProcessPointer ThisProcess)
 
void SetRefiningParameters (MesherUtilities::RefiningParameters &rRefiningParameters, double AlphaParameter, double CriticalRadius, double CriticalSide)
 
void SetThresholdVariable (MesherUtilities::RefiningParameters &rRefiningParameters, const Variable< double > &rVariable)
 
void SetErrorVariable (MesherUtilities::RefiningParameters &rRefiningParameters, const Variable< double > &rVariable)
 
const Variable< double > & GetThresholdVariable (MesherUtilities::RefiningParameters &rRefiningParameters)
 
void SetReferenceElement (MesherUtilities::MeshingParameters &rMeshingParameters, char *ElementName)
 
void SetReferenceCondition (MesherUtilities::MeshingParameters &rMeshingParameters, char *ConditionName)
 
void TransferNodesToElementsOnThreshold (MeshDataTransferUtilities &rMeshDataTransfer, MeshDataTransferUtilities::TransferParameters &rTransferParameters, MesherUtilities::RefiningParameters &rRefiningParameters, ModelPart &rModelPart)
 
void SetDoubleVariable (MeshDataTransferUtilities::TransferParameters &rTransferParameters, const Variable< double > &rVariable)
 
void SetArray1DVariable (MeshDataTransferUtilities::TransferParameters &rTransferParameters, const Variable< array_1d< double, 3 > > &rVariable)
 
void SetVectorVariable (MeshDataTransferUtilities::TransferParameters &rTransferParameters, const Variable< Vector > &rVariable)
 
void SetMatrixVariable (MeshDataTransferUtilities::TransferParameters &rTransferParameters, const Variable< Matrix > &rVariable)
 
pybind11::list Aux_MeasureTopHeight (PreUtilities &ThisPreUtils, ModelPart &rModelPart)
 
pybind11::list Aux_MeasureBotHeight (PreUtilities &ThisPreUtils, ModelPart &rModelPart)
 
Element::Pointer CreateSphericParticle1 (ParticleCreatorDestructor &r_creator_destructor, ModelPart &r_modelpart, int r_Elem_Id, const array_1d< double, 3 > &coordinates, Properties::Pointer r_params, const double radius, const Element &r_reference_element)
 
Element::Pointer CreateSphericParticle2 (ParticleCreatorDestructor &r_creator_destructor, ModelPart &r_modelpart, int r_Elem_Id, Node ::Pointer reference_node, Properties::Pointer r_params, const double radius, const Element &r_reference_element)
 
Element::Pointer CreateSphericParticle3 (ParticleCreatorDestructor &r_creator_destructor, ModelPart &r_modelpart, int r_Elem_Id, Node ::Pointer reference_node, Properties::Pointer r_params, const double radius, const std::string &element_name)
 
Element::Pointer CreateSphericParticle4 (ParticleCreatorDestructor &r_creator_destructor, ModelPart &r_modelpart, Node ::Pointer reference_node, Properties::Pointer r_params, const double radius, const std::string &element_name)
 
Element::Pointer CreateSphericParticle5 (ParticleCreatorDestructor &r_creator_destructor, ModelPart &r_modelpart, int r_Elem_Id, const array_1d< double, 3 > &coordinates, Properties::Pointer r_params, const double radius, const std::string &element_name)
 
Element::Pointer CreateSphericParticle6 (ParticleCreatorDestructor &r_creator_destructor, ModelPart &r_modelpart, const array_1d< double, 3 > &coordinates, Properties::Pointer r_params, const double radius, const std::string &element_name)
 
void CreatePropertiesProxies1 (PropertiesProxiesManager &r_properties_proxy_manager, ModelPart &r_modelpart)
 
void CreatePropertiesProxies2 (PropertiesProxiesManager &r_properties_proxy_manager, ModelPart &r_modelpart, ModelPart &r_inlet_modelpart, ModelPart &r_clusters_modelpart)
 
template<class TBinder , unsigned int TDim>
void DistanceSmoothingConstructionHelper (TBinder &rBinder)
 
void AddTrilinosProcessesToPython (pybind11::module &m)
 
void AddTrilinosSchemesToPython (pybind11::module &m)
 
void AddTrilinosStrategiesToPython (pybind11::module &m)
 
void AddTrilinosUtilitiesToPython (pybind11::module &m)
 
 PYBIND11_MODULE (KratosFluidDynamicsHydraulicsApplication, m)
 
void AddCustomEdgeBasedLevelSetToPython (pybind11::module &pymodule)
 
void AddMappersToPython (pybind11::module &m)
 
void AddCustomSolversToPython (pybind11::module &m)
 
void AddCustomDecompositionsToPython (pybind11::module &m)
 
template<typename SolverType >
void register_solver (pybind11::module &m, const std::string &name)
 
template<typename SolverType >
void register_dense_solver (pybind11::module &m, const std::string &name)
 
void register_dense_eigenvalue_solver (pybind11::module &m, const std::string &name)
 
void register_eigensystem_solver (pybind11::module &m, const std::string &name)
 
template<typename EigenSystemSolverType >
void register_feast_eigensystem_solver (pybind11::module &m, const std::string &name)
 
void register_spectra_sym_g_eigs_shift_solver (pybind11::module &m, const std::string &name)
 
void register_base_dense_solver (pybind11::module &m)
 
 PYBIND11_MODULE (KratosMedApplication, m)
 
void AddMeshersToPython (pybind11::module &m)
 
void AddMeshMovingStrategies (pybind11::module &m)
 
void AddCustomControlUtilitiesToPython (pybind11::module &m)
 
void AddCustomFiltersToPython (pybind11::module &m)
 
void AddCustomOptimizationAlgorithmToPython (pybind11::module &m)
 
void AddCustomResponseUtilitiesToPython (pybind11::module &m)
 
void Push_Back_Constitutive_Laws (MaterialsContainer &ThisMaterialsContainer, ConstitutiveLawPointer ThisConstitutiveLaw)
 
void AddCustomPropertiesToPython (pybind11::module &m)
 
void SearchElementAccordingToDimension (ModelPart &rBackgroundGridModelPart, ModelPart &rMPMModelPart, const std::size_t MaxNumberOfResults, const double Tolerance)
 
void GenerateMaterialPointElementAccordingToDimension (ModelPart &rBackgroundGridModelPart, ModelPart &rInitialModelPart, ModelPart &rMPMModelPart, bool IsMixedFormulation)
 
void GenerateMaterialPointConditionAccordingToDimension (ModelPart &rBackgroundGridModelPart, ModelPart &rInitialModelPart, ModelPart &rMPMModelPart)
 
void AddCustomMPIUtilitiesToPython (pybind11::module &m)
 
void AddCustomConditionsToPython (pybind11::module &m)
 
void AddCustomConditionsToPython ()
 
void AddCustomModelersToPython (pybind11::module &m)
 
void AddCustomModelersToPython (py::module &m)
 
template<class TContainerType >
array_1d< double, 3 > ComputeHydrostaticForces1 (ShallowWaterUtilities &rUtility, TContainerType &rContainer, const ProcessInfo &rProcessInfo)
 
template<class TContainerType >
array_1d< double, 3 > ComputeHydrostaticForces2 (ShallowWaterUtilities &rUtility, TContainerType &rContainer, const ProcessInfo &rProcessInfo, const double RelativeDryHeight)
 
template<typename TMapper >
void MapVector (TMapper &mapper, const Variable< array_1d< double, 3 > > &origin_variable, const Variable< array_1d< double, 3 > > &destination_variable)
 
template<typename TMapper >
void MapScalar (TMapper &mapper, const Variable< double > &origin_variable, const Variable< double > &destination_variable)
 
template<typename TMapper >
void InverseMapVector (TMapper &mapper, const Variable< array_1d< double, 3 > > &origin_variable, const Variable< array_1d< double, 3 > > &destination_variable)
 
template<typename TMapper >
void InverseMapScalar (TMapper &mapper, const Variable< double > &origin_variable, const Variable< double > &destination_variable)
 
void AssembleMatrixForVariableList (ModelPart &rModelPart, Matrix &rMatrix, pybind11::list &rVariables)
 
void Helper_SetCrossSectionsOnIntegrationPoints_Thin (ShellThinElement3D3N &el, const pybind11::list &seclist)
 
void Helper_SetCrossSectionsOnIntegrationPoints_Thick (ShellThickElement3D4N &el, const pybind11::list &seclist)
 
void AddCrossSectionsToPython (pybind11::module &m)
 
void TransferEigenvector1 (EigenvectorToSolutionStepVariableTransferUtility &rThisUtil, ModelPart &rModelPart, int iEigenMode)
 
void TransferEigenvector2 (EigenvectorToSolutionStepVariableTransferUtility &rThisUtil, ModelPart &rModelPart, int iEigenMode, int step)
 
void AddCustomMethodsToPython (pybind11::module &m)
 
void AddCustomSpatialMethodsToPython (pybind11::module &m)
 
void AddCustomTemporalMethodsToPython (pybind11::module &m)
 
template<class TDataType >
bool ModelPartHasNodalVariableOrNot (VariableChecker &rChecker, ModelPart &rModelPart, Variable< TDataType > const &rThisVariable)
 
template<class TValueType , unsigned int TDim>
void AuxiliarUpdateInterfaceValues (TrilinosPartitionedFSIUtilities< TrilinosSparseSpaceType, TValueType, TDim > &dummy, ModelPart &rModelPart, const Variable< TValueType > &rSolutionVariable, AuxiliaryVectorWrapper &rCorrectedGuess)
 
template<class TValueType , unsigned int TDim>
void AuxiliarComputeInterfaceResidualVector (TrilinosPartitionedFSIUtilities< TrilinosSparseSpaceType, TValueType, TDim > &dummy, ModelPart &rInterfaceModelPart, const Variable< TValueType > &rOriginalVariable, const Variable< TValueType > &rModifiedVariable, const Variable< TValueType > &rResidualVariable, AuxiliaryVectorWrapper &rInterfaceResidual, const std::string ResidualType="nodal", const Variable< double > &rResidualNormVariable=FSI_INTERFACE_RESIDUAL_NORM)
 
void AuxiliarUpdateSolution (ConvergenceAccelerator< TrilinosSparseSpaceType, TrilinosLocalSpaceType > &dummy, AuxiliaryVectorWrapper &rResidualVector, AuxiliaryVectorWrapper &rIterationGuess)
 
void AddTrilinosConvergenceAcceleratorsToPython (pybind11::module &m)
 
void AddConvergenceCriterias (pybind11::module &m)
 
void AddLinearSolvers (pybind11::module &m)
 
void AddProcesses (pybind11::module &m)
 
void AddSchemes (pybind11::module &m)
 
void AddBasicOperations (pybind11::module &m)
 
void AddStrategies (pybind11::module &m)
 
void WriteNodeMesh (GidIOType &dummy, GidIOType::MeshType &rThisMesh)
 
void WriteMesh (GidIOType &dummy, GidIOType::MeshType &rThisMesh)
 
void DoublePrintOnGaussPoints (GidIOType &dummy, const Variable< double > &rVariable, ModelPart &r_model_part, double SolutionTag)
 
void VectorPrintOnGaussPoints (GidIOType &dummy, const Variable< Vector > &rVariable, ModelPart &r_model_part, double SolutionTag)
 
void MatrixPrintOnGaussPoints (GidIOType &dummy, const Variable< Matrix > &rVariable, ModelPart &r_model_part, double SolutionTag)
 
void AddCustomIOToPython ()
 
void GenerateModelPart (NistUtils &NistUtils, ModelPart &origin_model_part, ModelPart &destination_model_part, unsigned int domain_size)
 
void TetRegeneratePfemUlf3D (TetGenPfemModeler &Mesher, ModelPart &model_part, double alpha_shape)
 
void TetRegeneratePfemUlf3DInc (TetGenPfemModeler &Mesher, ModelPart &model_part, double alpha_shape)
 
void TetRegeneratePfem3DInc (TetGenPfemModeler &Mesher, ModelPart &model_part, double alpha_shape)
 
void TriRefinePFEM (TriGenCDTrefine &Mesher, ModelPart &model_part, bool refine)
 
void TriRegenerate (TriGenModeler &Mesher, ModelPart &model_part, double alpha_shape)
 
void TriRegenerateCoupled (TriGenModeler &Mesher, ModelPart &model_part, double alpha_shape)
 
void TriRegenerateUpdatedLagrangian (TriGenModeler &Mesher, ModelPart &model_part, double alpha_shape)
 
void TriRegenerateUpdatedLagrangianTest (TriGenModeler &Mesher, ModelPart &model_part, double alpha_shape)
 
void TetRegenerateUpdatedLagrangian (TetGenModeler &Mesher, ModelPart &model_part, double alpha_shape)
 
void TetRegenerateUpdatedLagrangianInc (TetGenModeler &Mesher, ModelPart &model_part, double alpha_shape)
 
Set and Calculate
template<class TDataType >
void Assign (GeometryType &dummy, const Variable< TDataType > &rVariable, TDataType Value)
 
template<class TDataType >
TDataType Calculate (GeometryType &dummy, const Variable< TDataType > &rVariable)
 
Calculate on Integration Points
template<class TObject , class TDataType >
pybind11::list CalculateOnIntegrationPoints (TObject &dummy, const Variable< TDataType > &rVariable, const ProcessInfo &rProcessInfo)
 
template<class TObject >
pybind11::list CalculateOnIntegrationPointsBool (TObject &dummy, const Variable< bool > &rVariable, const ProcessInfo &rProcessInfo)
 
Get Values on Integration Points
template<class TObject >
void GetValuesOnIntegrationPoints (TObject &dummy, const Variable< Vector > &rVariable, const ProcessInfo &rCurrentProcessInfo)
 
Set Values on Integration Points
template<class TObject , class TDataType >
void SetValuesOnIntegrationPoints (TObject &dummy, const Variable< TDataType > &rVariable, const std::vector< TDataType > &values, const ProcessInfo &rCurrentProcessInfo)
 
template<class TObject , std::size_t TSize>
void SetValuesOnIntegrationPointsArray1d (TObject &dummy, const Variable< array_1d< double, TSize >> &rVariable, pybind11::list values_list, const ProcessInfo &rCurrentProcessInfo)
 
template<class TObject >
void SetValuesOnIntegrationPointsVector (TObject &dummy, const Variable< Vector > &rVariable, pybind11::list values_list, unsigned int len_values_list_item, const ProcessInfo &rCurrentProcessInfo)
 
template<class TEntityType , class TDataType >
TDataType EntityCalculateInterface (TEntityType &dummy, Variable< TDataType > &rVariable, const ProcessInfo &rCurrentProcessInfo)
 
void SetValuesOnIntegrationPointsConstitutiveLaw (Element &dummy, const Variable< ConstitutiveLaw::Pointer > &rVariable, pybind11::list values_list, const ProcessInfo &rCurrentProcessInfo)
 
template<class TEntityType >
void EntityCalculateRightHandSide (TEntityType &dummy, Vector &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo)
 
template<class TEntityType >
void EntityCalculateLocalSystem (TEntityType &dummy, Matrix &rLeftHandSideMatrix, Vector &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo)
 
template<class TEntityType >
void EntityCalculateMassMatrix (TEntityType &dummy, Matrix &rMassMatrix, const ProcessInfo &rCurrentProcessInfo)
 
template<class TEntityType >
void EntityCalculateDampingMatrix (TEntityType &dummy, Matrix &rDampingMatrix, const ProcessInfo &rCurrentProcessInfo)
 
void ElementCalculateLumpedMassVector (Element &dummy, Vector &rMassVector, const ProcessInfo &rCurrentProcessInfo)
 
template<class TEntityType >
void EntityCalculateFirstDerivativesLHS (TEntityType &dummy, Matrix &rLeftHandSideMatrix, const ProcessInfo &rCurrentProcessInfo)
 
template<class TEntityType >
void EntityCalculateSecondDerivativesLHS (TEntityType &dummy, Matrix &rLeftHandSideMatrix, const ProcessInfo &rCurrentProcessInfo)
 
template<class TEntityType >
void EntityCalculateLocalVelocityContribution (TEntityType &dummy, Matrix &rDampingMatrix, Vector &rRightHandSideVector, const ProcessInfo &rCurrentProcessInfo)
 
template<class TEntityType >
void EntityInitialize (TEntityType &dummy, const ProcessInfo &rCurrentProcessInfo)
 
template<class TEntityType , class TDataType >
void EntityCalculateSensitivityMatrix (TEntityType &dummy, const Variable< TDataType > &rDesignVariable, Matrix &rOutput, const ProcessInfo &rCurrentProcessInfo)
 
template<class TEntityType >
void EntityGetFirstDerivativesVector1 (const TEntityType &dummy, Vector &rOutput)
 
template<class TEntityType >
void EntityGetFirstDerivativesVector2 (const TEntityType &dummy, Vector &rOutput, int step)
 
template<class TEntityType >
void EntityGetSecondDerivativesVector1 (const TEntityType &dummy, Vector &rOutput)
 
template<class TEntityType >
void EntityGetSecondDerivativesVector2 (const TEntityType &dummy, Vector &rOutput, int step)
 
void AddMeshToPython (pybind11::module &m)
 

Variables

void(GidIO<>::* pointer_to_io_read_single_properties )(Properties &rThisProperties) = &IO::ReadProperties
 
void(GidIO<>::* pointer_to_io_read_properties )(IO::PropertiesContainerType &rThisProperties) = &IO::ReadProperties
 
void(GidIOType::* pointer_to_double_write_nodal_results )(Variable< double > const &rVariable, GidIOType::NodesContainerType &rNodes, double SolutionTag, std::size_t SolutionStepNumber) = &GidIOType::WriteNodalResults
 
void(GidIOType::* pointer_to_array1d_write_nodal_results )(Variable< array_1d< double, 3 > > const &rVariable, GidIOType::NodesContainerType &rNodes, double SolutionTag, std::size_t SolutionStepNumber) = &GidIOType::WriteNodalResults
 

Typedef Documentation

◆ BaseBuoyancyLawType

◆ BaseDragLawType

◆ BaseHistoryForceLaw

◆ BaseHydrodynamicInteractionLawType

◆ BaseInviscidForceLawType

◆ BaseRotationInducedLiftLawType

◆ BaseSteadyViscousTorqueLaw

◆ BaseVorticityInducedLiftLawType

◆ BoundingBoxContainer

typedef std::vector<SpatialBoundingBox::Pointer> Kratos::Python::BoundingBoxContainer

◆ BoundingBoxPointer

typedef SpatialBoundingBox::Pointer Kratos::Python::BoundingBoxPointer

◆ BoundingBoxType

◆ ComplexLinearSolverFactoryType

◆ ComplexLocalSpaceType

◆ ComplexSpaceType

◆ ComplexSparseSpaceType

typedef UblasSpace<std::complex<double>, ComplexCompressedMatrix, boost::numeric::ublas::vector<std::complex<double> > > Kratos::Python::ComplexSparseSpaceType

◆ ComponentIteratorType

typedef std::vector< array_1d< double, 3 > >::iterator Kratos::Python::ComponentIteratorType

◆ ComponentVectorType

typedef std::vector< array_1d< double, 3 > > Kratos::Python::ComponentVectorType

◆ ConditionBaseType

◆ ConditionsContainerType

◆ ConstitutiveLawBaseType

◆ ConstitutiveLawPointer

typedef ConstitutiveLaw::Pointer Kratos::Python::ConstitutiveLawPointer

◆ ConstitutiveModelBaseType

◆ ConstitutiveModelPointer

typedef ConstitutiveModel::Pointer Kratos::Python::ConstitutiveModelPointer

◆ ContiguousNumpyArray

template<class TDataType >
using Kratos::Python::ContiguousNumpyArray = typedef pybind11::array_t< TDataType, pybind11::array::c_style >

◆ ConvergenceCriteriaContainer

◆ ConvergenceCriterionPointerType

typedef ConvergenceCriterionType::Pointer Kratos::Python::ConvergenceCriterionPointerType

◆ ConvergenceCriterionType

◆ CoordinatesArrayType

◆ DataLocation

◆ DoubleTableType

◆ ElementsContainerType

◆ ExplicitBuilderFactoryType

◆ ExplicitBuilderType

◆ FlagsContainer

typedef std::vector< Flags > Kratos::Python::FlagsContainer

◆ FrictionLawPointerType

typedef FrictionLaw::Pointer Kratos::Python::FrictionLawPointerType

◆ GeometriesArrayType

◆ GeometryType

◆ GidIOBaseType

◆ GidIOType

◆ IndexType

typedef std::size_t Kratos::Python::IndexType

◆ IntegrationPointsArrayType

◆ LinearSolverFactoryType

◆ LinearSolverType

◆ LocalSpaceType

◆ MaterialsContainer

typedef std::vector< ConstitutiveLaw::Pointer > Kratos::Python::MaterialsContainer

◆ MesherProcessContainer

◆ MesherProcessPointer

typedef MesherProcess::Pointer Kratos::Python::MesherProcessPointer

◆ MeshType

◆ MPMFlowRulePointer

typedef ParticleFlowRule::Pointer Kratos::Python::MPMFlowRulePointer

◆ MPMHardeningLawPointer

typedef ParticleHardeningLaw::Pointer Kratos::Python::MPMHardeningLawPointer

◆ MPMYieldCriterionPointer

typedef ParticleYieldCriterion::Pointer Kratos::Python::MPMYieldCriterionPointer

◆ NodeContainerType

◆ NodesArrayType

◆ NodesContainerType

◆ NodeType

◆ PointIterator

◆ PointsArrayType

◆ PreconditionerFactoryType

◆ ProcessPointer

typedef Process::Pointer Kratos::Python::ProcessPointer

◆ PropertiesContainerType

◆ PropertiesPointer

typedef Properties::Pointer Kratos::Python::PropertiesPointer

◆ SizeType

typedef std::size_t Kratos::Python::SizeType

◆ SolutionBuilderAndSolverType

◆ SolutionSchemeType

◆ SolutionStrategiesContainer

typedef std::vector<SolutionStrategyType::Pointer> Kratos::Python::SolutionStrategiesContainer

◆ SolutionStrategyPointer

typedef SolutionStrategyType::Pointer Kratos::Python::SolutionStrategyPointer

◆ SolutionStrategyType

◆ SpaceType

using Kratos::Python::SpaceType = typedef UblasSpace<double, CompressedMatrix, boost::numeric::ublas::vector<double> >

◆ SparseSpaceType

◆ TDirectSolverType

template<class TDataType >
using Kratos::Python::TDirectSolverType = typedef DirectSolver<TUblasSparseSpace<TDataType>, TUblasDenseSpace<TDataType> >

◆ TLinearSolverType

template<class TDataType , class TOtherDataType >
using Kratos::Python::TLinearSolverType = typedef LinearSolver<TSpaceType<TDataType>, TLocalSpaceType<TOtherDataType> >

◆ TLocalSpaceType

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

◆ TrilinosDistanceSmoothingProcess

◆ TrilinosLinearSolverType

◆ TrilinosLocalSpaceType

◆ TrilinosSparseSpaceType

typedef TrilinosSpace< Epetra_FECrsMatrix, Epetra_FEVector > Kratos::Python::TrilinosSparseSpaceType

◆ TSpaceType

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

◆ UblasLocalSpaceType

Function Documentation

◆ ActiveHeatFluxAzenha()

void Kratos::Python::ActiveHeatFluxAzenha ( ConstructionUtility rThisUtil,
Parameters AzenhaParameters 
)
inline

◆ ActiveHeatFluxNoorzai()

void Kratos::Python::ActiveHeatFluxNoorzai ( ConstructionUtility rThisUtil,
Parameters NoorzaiParameters 
)
inline

◆ AddAccessorsToPython() [1/2]

void Kratos::Python::AddAccessorsToPython ( py::module &  m)

◆ AddAccessorsToPython() [2/2]

void Kratos::Python::AddAccessorsToPython ( pybind11::module &  m)

◆ AddALEVariablesToPython()

void Kratos::Python::AddALEVariablesToPython ( pybind11::module &  m)

◆ AddAMGCLSolverToPython()

void Kratos::Python::AddAMGCLSolverToPython ( pybind11::module &  m)

◆ AddBasicOperations()

void Kratos::Python::AddBasicOperations ( pybind11::module &  m)

◆ AddBoundingBoxToPython()

void Kratos::Python::AddBoundingBoxToPython ( pybind11::module &  m)

◆ AddCFDVariablesToPython()

void Kratos::Python::AddCFDVariablesToPython ( pybind11::module &  m)

◆ AddCommunicatorToPython()

void Kratos::Python::AddCommunicatorToPython ( pybind11::module &  m)

◆ AddConditionsByIds()

void Kratos::Python::AddConditionsByIds ( ModelPart rModelPart,
std::vector< ModelPart::IndexType > &  ConditionsIds 
)

◆ AddConstitutiveLawToPython()

void Kratos::Python::AddConstitutiveLawToPython ( pybind11::module &  m)

◆ AddConstraintToPython()

void Kratos::Python::AddConstraintToPython ( pybind11::module &  m)

◆ AddContainerExpressionToPython() [1/2]

void Kratos::Python::AddContainerExpressionToPython ( pybind11::module &  m)

◆ AddContainerExpressionToPython() [2/2]

template<class TContainerType >
void Kratos::Python::AddContainerExpressionToPython ( pybind11::module &  m,
const std::string &  rName 
)

◆ AddContainerExpressionUtilsToPython()

template<class TContainerType >
void Kratos::Python::AddContainerExpressionUtilsToPython ( pybind11::module &  m,
const std::string &  rName 
)

◆ AddContainersToPython()

void Kratos::Python::AddContainersToPython ( pybind11::module &  m)

◆ AddControllersToPython()

void Kratos::Python::AddControllersToPython ( pybind11::module &  m)

◆ AddConvergenceAcceleratorsToPython()

void Kratos::Python::AddConvergenceAcceleratorsToPython ( pybind11::module &  m)

◆ AddConvergenceCriterias()

void Kratos::Python::AddConvergenceCriterias ( pybind11::module &  m)

◆ AddCopyModelPartFlaggedInterface()

template<class TDataType >
void Kratos::Python::AddCopyModelPartFlaggedInterface ( pybind11::class_< VariableUtils > &  rPythonVariableUtils)

◆ AddCoSimIOToPython()

void Kratos::Python::AddCoSimIOToPython ( pybind11::module &  m)

◆ AddCrossSectionsToPython()

void Kratos::Python::AddCrossSectionsToPython ( pybind11::module &  m)

◆ AddCustomBoundingToPython()

void Kratos::Python::AddCustomBoundingToPython ( pybind11::module &  m)

◆ AddCustomConditionsToPython() [1/2]

void Kratos::Python::AddCustomConditionsToPython ( )

◆ AddCustomConditionsToPython() [2/2]

void Kratos::Python::AddCustomConditionsToPython ( pybind11::module &  m)

◆ AddCustomConstitutiveLawsToPython()

void Kratos::Python::AddCustomConstitutiveLawsToPython ( pybind11::module &  m)

◆ AddCustomControlUtilitiesToPython()

void Kratos::Python::AddCustomControlUtilitiesToPython ( pybind11::module &  m)

◆ AddCustomDecompositionsToPython()

void Kratos::Python::AddCustomDecompositionsToPython ( pybind11::module &  m)

◆ AddCustomEdgeBasedLevelSetToPython()

void Kratos::Python::AddCustomEdgeBasedLevelSetToPython ( pybind11::module &  pymodule)

◆ AddCustomFiltersToPython()

void Kratos::Python::AddCustomFiltersToPython ( pybind11::module &  m)

◆ AddCustomFrictionalLawsToPython()

void Kratos::Python::AddCustomFrictionalLawsToPython ( pybind11::module &  m)

◆ AddCustomFrictionLawsToPython()

void Kratos::Python::AddCustomFrictionLawsToPython ( pybind11::module &  m)

◆ AddCustomIOToPython() [1/2]

void Kratos::Python::AddCustomIOToPython ( )

◆ AddCustomIOToPython() [2/2]

void Kratos::Python::AddCustomIOToPython ( pybind11::module &  m)

◆ AddCustomLinearSolversToPython()

void Kratos::Python::AddCustomLinearSolversToPython ( pybind11::module &  m)

◆ AddCustomMeshersToPython()

void Kratos::Python::AddCustomMeshersToPython ( pybind11::module &  m)

◆ AddCustomMethodsToPython()

void Kratos::Python::AddCustomMethodsToPython ( pybind11::module &  m)

◆ AddCustomModelersToPython() [1/2]

void Kratos::Python::AddCustomModelersToPython ( py::module &  m)

◆ AddCustomModelersToPython() [2/2]

void Kratos::Python::AddCustomModelersToPython ( pybind11::module &  m)

◆ AddCustomMPIStrategiesToPython()

void Kratos::Python::AddCustomMPIStrategiesToPython ( pybind11::module &  m)

◆ AddCustomMPIUtilitiesToPython()

void Kratos::Python::AddCustomMPIUtilitiesToPython ( pybind11::module &  m)

◆ AddCustomOperationsToPython()

void Kratos::Python::AddCustomOperationsToPython ( pybind11::module &  m)

◆ AddCustomOptimizationAlgorithmToPython()

void Kratos::Python::AddCustomOptimizationAlgorithmToPython ( pybind11::module &  m)

◆ AddCustomProcessesToPython()

void Kratos::Python::AddCustomProcessesToPython ( pybind11::module &  m)

Processes

Processes

Properties container. A vector set of properties with their Id's as key.

Processes

Processes

Properties container. A vector set of properties with their Id's as key.

Processes

◆ AddCustomPropertiesToPython()

void Kratos::Python::AddCustomPropertiesToPython ( pybind11::module &  m)

◆ AddCustomResponseFunctionsToPython()

void Kratos::Python::AddCustomResponseFunctionsToPython ( pybind11::module &  m)

◆ AddCustomResponseFunctionUtilitiesToPython()

void Kratos::Python::AddCustomResponseFunctionUtilitiesToPython ( pybind11::module &  m)

◆ AddCustomResponseUtilitiesToPython()

void Kratos::Python::AddCustomResponseUtilitiesToPython ( pybind11::module &  m)

◆ AddCustomSolversToPython()

void Kratos::Python::AddCustomSolversToPython ( pybind11::module &  m)

◆ AddCustomSpatialMethodsToPython()

void Kratos::Python::AddCustomSpatialMethodsToPython ( pybind11::module &  m)

◆ AddCustomStrategiesToPython()

void Kratos::Python::AddCustomStrategiesToPython ( pybind11::module &  m)

◆ AddCustomTemporalMethodsToPython()

void Kratos::Python::AddCustomTemporalMethodsToPython ( pybind11::module &  m)

◆ AddCustomUtilitiesToPython()

void Kratos::Python::AddCustomUtilitiesToPython ( pybind11::module &  m)

◆ AddDataCommunicatorMethodForDataType()

template<class TModuleType , class TDataType >
void Kratos::Python::AddDataCommunicatorMethodForDataType ( TModuleType &  rDataCommunicatorModule)

◆ AddDataCommunicatorToPython()

void Kratos::Python::AddDataCommunicatorToPython ( pybind11::module &  m)

◆ AddDEMVariablesToPython()

void Kratos::Python::AddDEMVariablesToPython ( pybind11::module &  m)

◆ AddDeprecatedVariablesToPython()

void Kratos::Python::AddDeprecatedVariablesToPython ( pybind11::module &  m)

◆ AddDistributedSparseMatricesToPython()

void Kratos::Python::AddDistributedSparseMatricesToPython ( pybind11::module &  m)

◆ AddDofsToPython()

void Kratos::Python::AddDofsToPython ( pybind11::module &  m)

◆ AddElement1()

void Kratos::Python::AddElement1 ( ModelPart rModelPart,
Element::Pointer  pElement 
)

◆ AddElement2()

void Kratos::Python::AddElement2 ( ModelPart rModelPart,
Element::Pointer  pElement,
const ModelPart::IndexType  MeshId 
)

◆ AddElementsByIds()

void Kratos::Python::AddElementsByIds ( ModelPart rModelPart,
std::vector< ModelPart::IndexType > &  ElementsIds 
)

◆ AddExpressionIOToPython()

void Kratos::Python::AddExpressionIOToPython ( pybind11::module &  rModule)

◆ AddFactoriesToPython()

void Kratos::Python::AddFactoriesToPython ( pybind11::module &  m)

◆ AddFSIVariablesToPython()

void Kratos::Python::AddFSIVariablesToPython ( pybind11::module &  m)

◆ AddGeometricalUtilitiesToPython()

void Kratos::Python::AddGeometricalUtilitiesToPython ( pybind11::module &  m)

◆ AddGeometriesToPython()

void Kratos::Python::AddGeometriesToPython ( pybind11::module &  m)

Nurbs Geometries

◆ AddGlobalPointersToPython()

void Kratos::Python::AddGlobalPointersToPython ( pybind11::module &  m)

◆ AddGlobalsToPython()

void Kratos::Python::AddGlobalsToPython ( pybind11::module &  m)

◆ AddHistoricalVariableCheck() [1/2]

template<class TContainerType , class TVariableType >
void Kratos::Python::AddHistoricalVariableCheck ( pybind11::module &  m)

◆ AddHistoricalVariableCheck() [2/2]

template<class TContainerType >
void Kratos::Python::AddHistoricalVariableCheck ( pybind11::module &  m)

◆ AddHistoricalVariableCheckFolder()

template<class TContainerType , typename... args>
void Kratos::Python::AddHistoricalVariableCheckFolder ( pybind11::module &  m)

◆ AddInterfaceToAccessor()

template<typename... TArgs>
void Kratos::Python::AddInterfaceToAccessor ( pybind11::class_< Properties, Properties::Pointer, Properties::BaseType > &  pyProperties)

◆ AddInterfaceToAccessorFold()

template<typename TVariableType >
void Kratos::Python::AddInterfaceToAccessorFold ( pybind11::class_< Properties, Properties::Pointer, Properties::BaseType > &  pyProperties)

◆ AddIOToPython()

void Kratos::Python::AddIOToPython ( pybind11::module &  m)

◆ AddKernelToPython()

void Kratos::Python::AddKernelToPython ( pybind11::module &  m)

◆ AddKratosApplicationToPython()

void Kratos::Python::AddKratosApplicationToPython ( pybind11::module &  m)

◆ AddKratosParametersToPython()

void Kratos::Python::AddKratosParametersToPython ( pybind11::module &  m)

◆ AddLinearSolvers()

void Kratos::Python::AddLinearSolvers ( pybind11::module &  m)

◆ AddLinearSolversToPython()

void Kratos::Python::AddLinearSolversToPython ( pybind11::module &  m)

◆ AddLoggerToPython()

void Kratos::Python::AddLoggerToPython ( pybind11::module &  m)

◆ AddMappersToPython()

void Kratos::Python::AddMappersToPython ( pybind11::module &  m)

◆ AddMapperToPython()

void Kratos::Python::AddMapperToPython ( pybind11::module &  m)

◆ AddMappingToPython()

template<class TSparseSpace , class TDenseSpace >
void Kratos::Python::AddMappingToPython ( pybind11::module &  m)

◆ AddMappingVariablesToPython()

void Kratos::Python::AddMappingVariablesToPython ( pybind11::module &  m)

◆ AddMasterSlaveConstraintsByIds()

void Kratos::Python::AddMasterSlaveConstraintsByIds ( ModelPart rModelPart,
std::vector< ModelPart::IndexType > &  ConstraintIds 
)

◆ AddMatrixMarketInterfaceToPython()

void Kratos::Python::AddMatrixMarketInterfaceToPython ( pybind11::module &  m)

◆ AddMatrixToPython()

void Kratos::Python::AddMatrixToPython ( pybind11::module &  m)

◆ AddMATVariablesToPython()

void Kratos::Python::AddMATVariablesToPython ( pybind11::module &  m)

◆ AddMemoryInfoToPython()

void Kratos::Python::AddMemoryInfoToPython ( pybind11::module &  m)

◆ AddMeshersToPython()

void Kratos::Python::AddMeshersToPython ( pybind11::module &  m)

◆ AddMeshMovingStrategies()

void Kratos::Python::AddMeshMovingStrategies ( pybind11::module &  m)

◆ AddMeshToPython()

void Kratos::Python::AddMeshToPython ( pybind11::module &  m)

◆ AddModelerToPython()

void Kratos::Python::AddModelerToPython ( pybind11::module &  m)

◆ AddModelPartToPython()

void Kratos::Python::AddModelPartToPython ( pybind11::module &  m)

◆ AddModelToPython()

void Kratos::Python::AddModelToPython ( pybind11::module &  m)

◆ AddMPICommunicatorToPython()

void Kratos::Python::AddMPICommunicatorToPython ( pybind11::module &  m)

◆ AddMPIDataCommunicatorToPython()

void Kratos::Python::AddMPIDataCommunicatorToPython ( pybind11::module &  m)

◆ AddMPIDebugUtilitiesToPython()

void Kratos::Python::AddMPIDebugUtilitiesToPython ( pybind11::module &  m)

◆ AddMPISearchStrategiesToPython()

void Kratos::Python::AddMPISearchStrategiesToPython ( pybind11::module &  m)

◆ AddMPIUtilitiesToPython()

void Kratos::Python::AddMPIUtilitiesToPython ( pybind11::module &  m)

◆ AddNodalSolutionStepVariable()

template<class TDataType >
void Kratos::Python::AddNodalSolutionStepVariable ( ModelPart rModelPart,
Variable< TDataType > const &  rThisVariable 
)

◆ AddNode1()

void Kratos::Python::AddNode1 ( ModelPart rModelPart,
ModelPart::NodeType::Pointer  pNode 
)

◆ AddNode2()

void Kratos::Python::AddNode2 ( ModelPart rModelPart,
ModelPart::NodeType::Pointer  pNode,
const ModelPart::IndexType  MeshId 
)

◆ AddNodesByIds()

void Kratos::Python::AddNodesByIds ( ModelPart rModelPart,
std::vector< ModelPart::IndexType > &  NodesIds 
)

◆ AddNodeToPython()

void Kratos::Python::AddNodeToPython ( pybind11::module &  m)

◆ AddNonHistoricalVariableCheck() [1/2]

template<class TContainerType , class TVariableType >
void Kratos::Python::AddNonHistoricalVariableCheck ( pybind11::module &  m)

◆ AddNonHistoricalVariableCheck() [2/2]

template<class TContainerType >
void Kratos::Python::AddNonHistoricalVariableCheck ( pybind11::module &  m)

◆ AddNonHistoricalVariableCheckFolder()

template<class TContainerType , typename... args>
void Kratos::Python::AddNonHistoricalVariableCheckFolder ( pybind11::module &  m)

◆ AddOperationsToPython()

void Kratos::Python::AddOperationsToPython ( pybind11::module &  m)

◆ AddOtherUtilitiesToPython()

void Kratos::Python::AddOtherUtilitiesToPython ( pybind11::module &  m)

◆ AddParallelEnvironmentToPython()

void Kratos::Python::AddParallelEnvironmentToPython ( pybind11::module &  m)

◆ AddPointsToPython()

void Kratos::Python::AddPointsToPython ( pybind11::module &  m)

◆ AddProcesses()

void Kratos::Python::AddProcesses ( pybind11::module &  m)

◆ AddProcessesToPython()

void Kratos::Python::AddProcessesToPython ( pybind11::module &  m)

◆ AddProcessInfoToPython()

void Kratos::Python::AddProcessInfoToPython ( pybind11::module &  m)

◆ AddPropertiesToPython()

void Kratos::Python::AddPropertiesToPython ( pybind11::module &  m)

◆ AddQuaternionToPython()

void Kratos::Python::AddQuaternionToPython ( pybind11::module &  m)

◆ AddRegistryToPython()

void Kratos::Python::AddRegistryToPython ( pybind11::module &  m)

◆ AddResponseFunctionsToPython()

void Kratos::Python::AddResponseFunctionsToPython ( pybind11::module &  m)

◆ AddSchemes()

void Kratos::Python::AddSchemes ( pybind11::module &  m)

◆ AddSearchStrategiesToPython()

void Kratos::Python::AddSearchStrategiesToPython ( pybind11::module &  m)

The variables of the spatial search

◆ AddSerializerToPython()

void Kratos::Python::AddSerializerToPython ( pybind11::module &  m)

◆ AddSparseMatricesToPython()

void Kratos::Python::AddSparseMatricesToPython ( pybind11::module &  m)

◆ AddStrategies()

void Kratos::Python::AddStrategies ( pybind11::module &  m)

◆ AddStrategiesToPython()

void Kratos::Python::AddStrategiesToPython ( pybind11::module &  m)

◆ AddSubModelPartEntitiesBooleanOperationToPython()

template<class TEntityType , class TContainerType >
void Kratos::Python::AddSubModelPartEntitiesBooleanOperationToPython ( pybind11::module &  m,
std::string  Name 
)

◆ AddTableToPython()

void Kratos::Python::AddTableToPython ( pybind11::module &  m)

◆ AddTestingToPython()

void Kratos::Python::AddTestingToPython ( pybind11::module &  m)

◆ AddTrilinosConvergenceAcceleratorsToPython()

void Kratos::Python::AddTrilinosConvergenceAcceleratorsToPython ( pybind11::module &  m)

◆ AddTrilinosProcessesToPython()

void Kratos::Python::AddTrilinosProcessesToPython ( pybind11::module &  m)

◆ AddTrilinosSchemesToPython()

void Kratos::Python::AddTrilinosSchemesToPython ( pybind11::module &  m)

◆ AddTrilinosStrategiesToPython()

void Kratos::Python::AddTrilinosStrategiesToPython ( pybind11::module &  m)

◆ AddTrilinosUtilitiesToPython()

void Kratos::Python::AddTrilinosUtilitiesToPython ( pybind11::module &  m)

◆ AddVariableUtilsToPython()

void Kratos::Python::AddVariableUtilsToPython ( pybind11::module &  m)

◆ AddVectorToPython()

void Kratos::Python::AddVectorToPython ( pybind11::module &  m)

◆ AllocateNumpyArray()

template<class TDataType >
pybind11::array_t<TDataType> Kratos::Python::AllocateNumpyArray ( const std::size_t  NumberOfEntities,
const std::vector< std::size_t > &  rShape 
)

◆ Append()

template<class T >
void Kratos::Python::Append ( Parameters rParameters,
const T &  obj 
)

◆ ApplyFixity()

template<class TVarType >
void Kratos::Python::ApplyFixity ( VariableUtils rVariableUtils,
const TVarType &  rVar,
const bool  IsFixed,
ModelPart::NodesContainerType rNodes 
)

◆ ApplyFlaggedFixity()

template<class TVarType >
void Kratos::Python::ApplyFlaggedFixity ( VariableUtils rVariableUtils,
const TVarType &  rVar,
const bool  IsFixed,
ModelPart::NodesContainerType rNodes,
const Flags rFlag,
const bool  CheckValue 
)

◆ AssembleMatrixForVariableList()

void Kratos::Python::AssembleMatrixForVariableList ( ModelPart rModelPart,
Matrix rMatrix,
pybind11::list &  rVariables 
)
inline

◆ Assign()

template<class TDataType >
void Kratos::Python::Assign ( GeometryType dummy,
const Variable< TDataType > &  rVariable,
TDataType  Value 
)

◆ AssignTimeActivation()

void Kratos::Python::AssignTimeActivation ( ConstructionUtility rThisUtil,
std::string  ThermalSubModelPartName,
int  phase,
double  time_activation,
double  initial_temperature 
)
inline

◆ Aux_MeasureBotHeight()

pybind11::list Kratos::Python::Aux_MeasureBotHeight ( PreUtilities ThisPreUtils,
ModelPart rModelPart 
)

◆ Aux_MeasureTopHeight()

pybind11::list Kratos::Python::Aux_MeasureTopHeight ( PreUtilities ThisPreUtils,
ModelPart rModelPart 
)

◆ AuxiliarComputeInterfaceResidualVector()

template<class TValueType , unsigned int TDim>
void Kratos::Python::AuxiliarComputeInterfaceResidualVector ( TrilinosPartitionedFSIUtilities< TrilinosSparseSpaceType, TValueType, TDim > &  dummy,
ModelPart rInterfaceModelPart,
const Variable< TValueType > &  rOriginalVariable,
const Variable< TValueType > &  rModifiedVariable,
const Variable< TValueType > &  rResidualVariable,
AuxiliaryVectorWrapper rInterfaceResidual,
const std::string  ResidualType = "nodal",
const Variable< double > &  rResidualNormVariable = FSI_INTERFACE_RESIDUAL_NORM 
)

◆ AuxiliarUpdateInterfaceValues()

template<class TValueType , unsigned int TDim>
void Kratos::Python::AuxiliarUpdateInterfaceValues ( TrilinosPartitionedFSIUtilities< TrilinosSparseSpaceType, TValueType, TDim > &  dummy,
ModelPart rModelPart,
const Variable< TValueType > &  rSolutionVariable,
AuxiliaryVectorWrapper rCorrectedGuess 
)

◆ AuxiliarUpdateSolution()

void Kratos::Python::AuxiliarUpdateSolution ( ConvergenceAccelerator< TrilinosSparseSpaceType, TrilinosLocalSpaceType > &  dummy,
AuxiliaryVectorWrapper rResidualVector,
AuxiliaryVectorWrapper rIterationGuess 
)

◆ AuxiliaryCalculateMLSShapeFunctions()

void Kratos::Python::AuxiliaryCalculateMLSShapeFunctions ( const std::size_t  Dim,
const std::size_t  Order,
const Matrix rPoints,
const array_1d< double, 3 > &  rX,
const double  h,
Vector rN 
)

◆ AuxiliaryCalculateMLSShapeFunctionsAndGradients()

void Kratos::Python::AuxiliaryCalculateMLSShapeFunctionsAndGradients ( const std::size_t  Dim,
const std::size_t  Order,
const Matrix rPoints,
const array_1d< double, 3 > &  rX,
const double  h,
Vector rN,
Matrix rDNDX 
)

◆ Calculate()

template<class TDataType >
TDataType Kratos::Python::Calculate ( GeometryType dummy,
const Variable< TDataType > &  rVariable 
)

◆ CalculateDiscontinuousEmbeddedVariableFromSkinArray()

template<std::size_t TDim>
void Kratos::Python::CalculateDiscontinuousEmbeddedVariableFromSkinArray ( CalculateDiscontinuousDistanceToSkinProcess< TDim > &  rDiscDistProcess,
const Variable< array_1d< double, 3 >> &  rVariable,
const Variable< array_1d< double, 3 >> &  rEmbeddedVariable 
)

◆ CalculateDiscontinuousEmbeddedVariableFromSkinDouble()

template<std::size_t TDim>
void Kratos::Python::CalculateDiscontinuousEmbeddedVariableFromSkinDouble ( CalculateDiscontinuousDistanceToSkinProcess< TDim > &  rDiscDistProcess,
const Variable< double > &  rVariable,
const Variable< double > &  rEmbeddedVariable 
)

◆ CalculateEmbeddedVariableFromSkinArray()

template<std::size_t TDim>
void Kratos::Python::CalculateEmbeddedVariableFromSkinArray ( CalculateDistanceToSkinProcess< TDim > &  rDistProcess,
const Variable< array_1d< double, 3 >> &  rVariable,
const Variable< array_1d< double, 3 >> &  rEmbeddedVariable 
)

◆ CalculateEmbeddedVariableFromSkinDouble()

template<std::size_t TDim>
void Kratos::Python::CalculateEmbeddedVariableFromSkinDouble ( CalculateDistanceToSkinProcess< TDim > &  rDistProcess,
const Variable< double > &  rVariable,
const Variable< double > &  rEmbeddedVariable 
)

◆ CalculateOnIntegrationPoints()

template<class TObject , class TDataType >
pybind11::list Kratos::Python::CalculateOnIntegrationPoints ( TObject &  dummy,
const Variable< TDataType > &  rVariable,
const ProcessInfo rProcessInfo 
)

◆ CalculateOnIntegrationPointsBool()

template<class TObject >
pybind11::list Kratos::Python::CalculateOnIntegrationPointsBool ( TObject &  dummy,
const Variable< bool > &  rVariable,
const ProcessInfo rProcessInfo 
)

◆ ClearMatrix()

template<typename TSpaceType >
void Kratos::Python::ClearMatrix ( TSpaceType dummy,
typename TSpaceType::MatrixPointerType A 
)

◆ ClearVector()

template<typename TSpaceType >
void Kratos::Python::ClearVector ( TSpaceType dummy,
typename TSpaceType::VectorPointerType x 
)

◆ CommunicatorAssembleCurrentData()

template<class TDataType >
bool Kratos::Python::CommunicatorAssembleCurrentData ( Communicator rCommunicator,
Variable< TDataType > const &  ThisVariable 
)

◆ CommunicatorAssembleNonHistoricalData()

template<class TDataType >
bool Kratos::Python::CommunicatorAssembleNonHistoricalData ( Communicator rCommunicator,
Variable< TDataType > const &  ThisVariable 
)

◆ CommunicatorSynchronizeNonHistoricalVariable()

template<class TDataType >
bool Kratos::Python::CommunicatorSynchronizeNonHistoricalVariable ( Communicator rCommunicator,
Variable< TDataType > const &  ThisVariable 
)

◆ CommunicatorSynchronizeVariable()

template<class TDataType >
bool Kratos::Python::CommunicatorSynchronizeVariable ( Communicator rCommunicator,
Variable< TDataType > const &  ThisVariable 
)

◆ ComputeHydrostaticForces1()

template<class TContainerType >
array_1d<double,3> Kratos::Python::ComputeHydrostaticForces1 ( ShallowWaterUtilities rUtility,
TContainerType &  rContainer,
const ProcessInfo rProcessInfo 
)

◆ ComputeHydrostaticForces2()

template<class TContainerType >
array_1d<double,3> Kratos::Python::ComputeHydrostaticForces2 ( ShallowWaterUtilities rUtility,
TContainerType &  rContainer,
const ProcessInfo rProcessInfo,
const double  RelativeDryHeight 
)

◆ ComputeNodesTangentModelPartWithOutSlipVariable()

void Kratos::Python::ComputeNodesTangentModelPartWithOutSlipVariable ( ModelPart rModelPart,
const double  SlipCoefficient,
const bool  SlipAlways 
)

◆ ComputeNodesTangentModelPartWithOutSlipVariableNotAlwaysSlip()

void Kratos::Python::ComputeNodesTangentModelPartWithOutSlipVariableNotAlwaysSlip ( ModelPart rModelPart,
const double  SlipCoefficient 
)

◆ ComputeNodesTangentModelPartWithOutSlipVariableNotAlwaysSlipUnitary()

void Kratos::Python::ComputeNodesTangentModelPartWithOutSlipVariableNotAlwaysSlipUnitary ( ModelPart rModelPart)

◆ ComputeNodesTangentModelPartWithSlipVariable()

void Kratos::Python::ComputeNodesTangentModelPartWithSlipVariable ( ModelPart rModelPart,
const Variable< array_1d< double, 3 >> &  rSlipVariable,
const double  SlipCoefficient,
const bool  SlipAlways 
)

◆ ComputeNodesTangentModelPartWithSlipVariableNotAlwaysSlip()

void Kratos::Python::ComputeNodesTangentModelPartWithSlipVariableNotAlwaysSlip ( ModelPart rModelPart,
const Variable< array_1d< double, 3 >> &  rSlipVariable,
const double  SlipCoefficient 
)

◆ ComputeNodesTangentModelPartWithSlipVariableNotAlwaysSlipUnitary()

void Kratos::Python::ComputeNodesTangentModelPartWithSlipVariableNotAlwaysSlipUnitary ( ModelPart rModelPart,
const Variable< array_1d< double, 3 >> &  rSlipVariable 
)

◆ ConditionCalculateLocalSystemStandard()

void Kratos::Python::ConditionCalculateLocalSystemStandard ( Condition dummy,
Matrix rLeftHandSideMatrix,
Vector rRightHandSideVector,
const ProcessInfo rCurrentProcessInfo 
)

◆ ConstGetPoints()

const PointerVector< Node >& Kratos::Python::ConstGetPoints ( GeometryType geom)

◆ ConstitutiveLawCalculateValue()

template<class TDataType >
const TDataType Kratos::Python::ConstitutiveLawCalculateValue ( ConstitutiveLaw rThisConstitutiveLaw,
ConstitutiveLaw::Parameters rValues,
const Variable< TDataType > &  rThisVariable,
TDataType &  value 
)

◆ ConstitutiveLawGetValue()

template<class TDataType >
const TDataType Kratos::Python::ConstitutiveLawGetValue ( ConstitutiveLaw rThisConstitutiveLaw,
const Variable< TDataType > &  rThisVariable,
TDataType &  value 
)

◆ ConstitutiveLawHas()

template<class TVariableType >
bool Kratos::Python::ConstitutiveLawHas ( ConstitutiveLaw rThisConstitutiveLaw,
TVariableType const &  rThisVariable 
)

◆ ConstitutiveLawSetValue()

template<class TDataType >
void Kratos::Python::ConstitutiveLawSetValue ( ConstitutiveLaw rThisConstitutiveLaw,
const Variable< TDataType > &  rThisVariable,
TDataType &  value,
const ProcessInfo rCurrentProcessInfo 
)

◆ CopyModelPartNodalVarToNonHistoricalVar()

template<class TVarType >
void Kratos::Python::CopyModelPartNodalVarToNonHistoricalVar ( VariableUtils rVariableUtils,
const TVarType &  rVariable,
const ModelPart rOriginModelPart,
ModelPart rDestinationModelPart,
const unsigned int  BuffStep = 0 
)

◆ CopyModelPartNodalVarToNonHistoricalVarWithDestination()

template<class TVarType >
void Kratos::Python::CopyModelPartNodalVarToNonHistoricalVarWithDestination ( VariableUtils rVariableUtils,
const TVarType &  rVariable,
const TVarType &  rDestinationVariable,
const ModelPart rOriginModelPart,
ModelPart rDestinationModelPart,
const unsigned int  BuffStep = 0 
)

◆ CopyRadiusArrayToPython() [1/2]

SpatialSearch::RadiusArrayType Kratos::Python::CopyRadiusArrayToPython ( const pybind11::list &  rListOfRadius)

Copies a Python list of radius to a C++ radius array.

Parameters
rListOfRadiuslist of radius to copy
Returns
Radius array with copied radius

◆ CopyRadiusArrayToPython() [2/2]

void Kratos::Python::CopyRadiusArrayToPython ( const pybind11::list &  rListOfRadius,
SpatialSearch::RadiusArrayType rRadiusArray 
)

Copies a list of doubles to a radius array.

Parameters
rListOfRadiusThe list of doubles to be copied
rRadiusArrayThe radius array to be filled

◆ CreateArray1DInterface()

template<std::size_t TSize>
void Kratos::Python::CreateArray1DInterface ( pybind11::module &  m,
const std::string &  Name 
)

◆ CreateEmptyMatrixPointer()

template<typename TSpaceType >
TSpaceType::MatrixPointerType Kratos::Python::CreateEmptyMatrixPointer ( TSpaceType dummy)

◆ CreateEmptyVectorPointer()

template<typename TSpaceType >
TSpaceType::VectorPointerType Kratos::Python::CreateEmptyVectorPointer ( TSpaceType dummy)

◆ CreateFromListOfRanks()

const DataCommunicator& Kratos::Python::CreateFromListOfRanks ( const DataCommunicator rReferenceComm,
pybind11::list &  rRanks,
const std::string &  rNewName 
)

◆ CreateMatrixInterface()

template<typename TMatrixType >
py::class_< TMatrixType > Kratos::Python::CreateMatrixInterface ( pybind11::module &  m,
std::string  Name 
)

◆ CreateNewMasterSlaveConstraint1()

ModelPart::MasterSlaveConstraintType::Pointer Kratos::Python::CreateNewMasterSlaveConstraint1 ( ModelPart rModelPart,
std::string  ConstraintName,
ModelPart::IndexType  Id,
ModelPart::DofsVectorType rMasterDofsVector,
ModelPart::DofsVectorType rSlaveDofsVector,
ModelPart::MatrixType  RelationMatrix,
ModelPart::VectorType  ConstantVector 
)

◆ CreateNewMasterSlaveConstraint2()

ModelPart::MasterSlaveConstraintType::Pointer Kratos::Python::CreateNewMasterSlaveConstraint2 ( ModelPart rModelPart,
std::string  ConstraintName,
ModelPart::IndexType  Id,
ModelPart::NodeType rMasterNode,
ModelPart::DoubleVariableType rMasterVariable,
ModelPart::NodeType rSlaveNode,
ModelPart::DoubleVariableType rSlaveVariable,
double  Weight,
double  Constant 
)

◆ CreatePropertiesProxies1()

void Kratos::Python::CreatePropertiesProxies1 ( PropertiesProxiesManager r_properties_proxy_manager,
ModelPart r_modelpart 
)

◆ CreatePropertiesProxies2()

void Kratos::Python::CreatePropertiesProxies2 ( PropertiesProxiesManager r_properties_proxy_manager,
ModelPart r_modelpart,
ModelPart r_inlet_modelpart,
ModelPart r_clusters_modelpart 
)

◆ CreateSpaceInterface()

template<typename TSpaceType >
py::class_< TSpaceType > Kratos::Python::CreateSpaceInterface ( pybind11::module &  m,
std::string  Name 
)

◆ CreateSphericParticle1()

Element::Pointer Kratos::Python::CreateSphericParticle1 ( ParticleCreatorDestructor r_creator_destructor,
ModelPart r_modelpart,
int  r_Elem_Id,
const array_1d< double, 3 > &  coordinates,
Properties::Pointer  r_params,
const double  radius,
const Element r_reference_element 
)

◆ CreateSphericParticle2()

Element::Pointer Kratos::Python::CreateSphericParticle2 ( ParticleCreatorDestructor r_creator_destructor,
ModelPart r_modelpart,
int  r_Elem_Id,
Node ::Pointer  reference_node,
Properties::Pointer  r_params,
const double  radius,
const Element r_reference_element 
)

◆ CreateSphericParticle3()

Element::Pointer Kratos::Python::CreateSphericParticle3 ( ParticleCreatorDestructor r_creator_destructor,
ModelPart r_modelpart,
int  r_Elem_Id,
Node ::Pointer  reference_node,
Properties::Pointer  r_params,
const double  radius,
const std::string &  element_name 
)

◆ CreateSphericParticle4()

Element::Pointer Kratos::Python::CreateSphericParticle4 ( ParticleCreatorDestructor r_creator_destructor,
ModelPart r_modelpart,
Node ::Pointer  reference_node,
Properties::Pointer  r_params,
const double  radius,
const std::string &  element_name 
)

◆ CreateSphericParticle5()

Element::Pointer Kratos::Python::CreateSphericParticle5 ( ParticleCreatorDestructor r_creator_destructor,
ModelPart r_modelpart,
int  r_Elem_Id,
const array_1d< double, 3 > &  coordinates,
Properties::Pointer  r_params,
const double  radius,
const std::string &  element_name 
)

◆ CreateSphericParticle6()

Element::Pointer Kratos::Python::CreateSphericParticle6 ( ParticleCreatorDestructor r_creator_destructor,
ModelPart r_modelpart,
const array_1d< double, 3 > &  coordinates,
Properties::Pointer  r_params,
const double  radius,
const std::string &  element_name 
)

◆ CreateVectorInterface()

template<typename TVectorType >
py::class_< TVectorType > Kratos::Python::CreateVectorInterface ( pybind11::module &  m,
std::string  Name 
)

◆ CreateWithoutProperties()

ConstitutiveLaw::Pointer Kratos::Python::CreateWithoutProperties ( ConstitutiveLaw rThisConstitutiveLaw,
Kratos::Parameters  NewParameters 
)

◆ CreateWithProperties()

ConstitutiveLaw::Pointer Kratos::Python::CreateWithProperties ( ConstitutiveLaw rThisConstitutiveLaw,
Kratos::Parameters  NewParameters,
const Properties rProperties 
)

◆ DataValueContainerIndexingUtility()

template<class TBinderType , typename TContainerType , typename TVariableType >
void Kratos::Python::DataValueContainerIndexingUtility ( TBinderType &  binder)

◆ DefineSimpleMortarMapperProcess()

template<std::size_t TDim, std::size_t TNumNodes, class TVariableType , const SizeType TNumNodesMaster = TNumNodes>
void Kratos::Python::DefineSimpleMortarMapperProcess ( pybind11::module &  m,
const std::string &  className 
)

◆ DefineSpecializedSpatialSearch()

template<SpatialContainer TSearchBackend>
void Kratos::Python::DefineSpecializedSpatialSearch ( pybind11::module &  m,
const std::string &  rClassName 
)

Defines a specialized spatial search module in Pybind11.

Parameters
mThe Pybind11 module to define the specialized spatial search in.
rClassNameThe name of the specialized spatial search class.

◆ DistanceSmoothingConstructionHelper()

template<class TBinder , unsigned int TDim>
void Kratos::Python::DistanceSmoothingConstructionHelper ( TBinder &  rBinder)

◆ Dot()

double Kratos::Python::Dot ( SparseSpaceType dummy,
SparseSpaceType::VectorType rX,
SparseSpaceType::VectorType rY 
)

◆ DoublePrintOnGaussPoints()

void Kratos::Python::DoublePrintOnGaussPoints ( GidIOType dummy,
const Variable< double > &  rVariable,
ModelPart r_model_part,
double  SolutionTag 
)

◆ ElementCalculateLumpedMassVector()

void Kratos::Python::ElementCalculateLumpedMassVector ( Element dummy,
Vector rMassVector,
const ProcessInfo rCurrentProcessInfo 
)

◆ EntityCalculateDampingMatrix()

template<class TEntityType >
void Kratos::Python::EntityCalculateDampingMatrix ( TEntityType &  dummy,
Matrix rDampingMatrix,
const ProcessInfo rCurrentProcessInfo 
)

◆ EntityCalculateFirstDerivativesLHS()

template<class TEntityType >
void Kratos::Python::EntityCalculateFirstDerivativesLHS ( TEntityType &  dummy,
Matrix rLeftHandSideMatrix,
const ProcessInfo rCurrentProcessInfo 
)

◆ EntityCalculateInterface()

template<class TEntityType , class TDataType >
TDataType Kratos::Python::EntityCalculateInterface ( TEntityType &  dummy,
Variable< TDataType > &  rVariable,
const ProcessInfo rCurrentProcessInfo 
)

◆ EntityCalculateLocalSystem()

template<class TEntityType >
void Kratos::Python::EntityCalculateLocalSystem ( TEntityType &  dummy,
Matrix rLeftHandSideMatrix,
Vector rRightHandSideVector,
const ProcessInfo rCurrentProcessInfo 
)

◆ EntityCalculateLocalVelocityContribution()

template<class TEntityType >
void Kratos::Python::EntityCalculateLocalVelocityContribution ( TEntityType &  dummy,
Matrix rDampingMatrix,
Vector rRightHandSideVector,
const ProcessInfo rCurrentProcessInfo 
)

◆ EntityCalculateMassMatrix()

template<class TEntityType >
void Kratos::Python::EntityCalculateMassMatrix ( TEntityType &  dummy,
Matrix rMassMatrix,
const ProcessInfo rCurrentProcessInfo 
)

◆ EntityCalculateRightHandSide()

template<class TEntityType >
void Kratos::Python::EntityCalculateRightHandSide ( TEntityType &  dummy,
Vector rRightHandSideVector,
const ProcessInfo rCurrentProcessInfo 
)

◆ EntityCalculateSecondDerivativesLHS()

template<class TEntityType >
void Kratos::Python::EntityCalculateSecondDerivativesLHS ( TEntityType &  dummy,
Matrix rLeftHandSideMatrix,
const ProcessInfo rCurrentProcessInfo 
)

◆ EntityCalculateSensitivityMatrix()

template<class TEntityType , class TDataType >
void Kratos::Python::EntityCalculateSensitivityMatrix ( TEntityType &  dummy,
const Variable< TDataType > &  rDesignVariable,
Matrix rOutput,
const ProcessInfo rCurrentProcessInfo 
)

◆ EntityGetFirstDerivativesVector1()

template<class TEntityType >
void Kratos::Python::EntityGetFirstDerivativesVector1 ( const TEntityType &  dummy,
Vector rOutput 
)

◆ EntityGetFirstDerivativesVector2()

template<class TEntityType >
void Kratos::Python::EntityGetFirstDerivativesVector2 ( const TEntityType &  dummy,
Vector rOutput,
int  step 
)

◆ EntityGetSecondDerivativesVector1()

template<class TEntityType >
void Kratos::Python::EntityGetSecondDerivativesVector1 ( const TEntityType &  dummy,
Vector rOutput 
)

◆ EntityGetSecondDerivativesVector2()

template<class TEntityType >
void Kratos::Python::EntityGetSecondDerivativesVector2 ( const TEntityType &  dummy,
Vector rOutput,
int  step 
)

◆ EntityInitialize()

template<class TEntityType >
void Kratos::Python::EntityInitialize ( TEntityType &  dummy,
const ProcessInfo rCurrentProcessInfo 
)

◆ EraseHelperFunction1()

template<class TContainerType , class TVariableType >
void Kratos::Python::EraseHelperFunction1 ( TContainerType &  rContainer,
const TVariableType &  rVar 
)

◆ FlagsAnd()

Flags Kratos::Python::FlagsAnd ( const Flags Left,
const Flags Right 
)

◆ FlagsOr()

Flags Kratos::Python::FlagsOr ( const Flags Left,
const Flags Right 
)

◆ FlagsSet1()

void Kratos::Python::FlagsSet1 ( Flags ThisFlag,
const Flags OtherFlag 
)

◆ FlagsSet2()

void Kratos::Python::FlagsSet2 ( Flags ThisFlag,
const Flags OtherFlag,
bool  Value 
)

◆ GenerateListFromVectorOfVector()

template<class TClass >
void Kratos::Python::GenerateListFromVectorOfVector ( pybind11::list &  rList,
const TClass &  rVector 
)

Generates a list of lists from a vector of vectors.

Parameters
rListThe list to be filled
rVectorThe vector of vectors to be copied
Template Parameters
TClassThe type of the vector of vectors

◆ GenerateMaterialPointConditionAccordingToDimension()

void Kratos::Python::GenerateMaterialPointConditionAccordingToDimension ( ModelPart rBackgroundGridModelPart,
ModelPart rInitialModelPart,
ModelPart rMPMModelPart 
)

◆ GenerateMaterialPointElementAccordingToDimension()

void Kratos::Python::GenerateMaterialPointElementAccordingToDimension ( ModelPart rBackgroundGridModelPart,
ModelPart rInitialModelPart,
ModelPart rMPMModelPart,
bool  IsMixedFormulation 
)

◆ GenerateMesh()

void Kratos::Python::GenerateMesh ( Modeler GM,
ModelPart model_part,
const std::string &  rElementName,
const std::string &  rConditionName 
)

◆ GenerateModelPart() [1/2]

void Kratos::Python::GenerateModelPart ( FaceHeatUtilities FaceHeatUtilities,
ModelPart origin_model_part,
ModelPart destination_model_part,
unsigned int  domain_size 
)

◆ GenerateModelPart() [2/2]

void Kratos::Python::GenerateModelPart ( NistUtils NistUtils,
ModelPart origin_model_part,
ModelPart destination_model_part,
unsigned int  domain_size 
)

◆ GeneratePartialModelPart()

void Kratos::Python::GeneratePartialModelPart ( ConnectivityPreserveModeler GM,
ModelPart origin_model_part,
ModelPart destination_model_part,
const std::string &  rName 
)

◆ GenerateSpatialSearchSolutionTuple()

template<class TClass >
std::tuple<pybind11::list, pybind11::list> Kratos::Python::GenerateSpatialSearchSolutionTuple ( const TClass &  rResults,
SpatialSearch::VectorDistanceType rDistances 
)

Generates a tuple of two python lists containing the elements and distances of a spatial search result.

Parameters
rResultsa reference to a vector containing the result elements to be copied to the python list
rDistancesa reference to a vector containing the distances to be copied to the python list
Returns
A tuple containing two python lists, the first one containing the result elements and the second one containing the distances
Template Parameters
TClassThe type of the class.

◆ GetArrayItem()

Parameters Kratos::Python::GetArrayItem ( Parameters rParameters,
const std::size_t  Index 
)

◆ GetConstitutiveLaw()

const ConstitutiveLaw& Kratos::Python::GetConstitutiveLaw ( Kernel rKernel,
const std::string &  constitutive_law_name 
)

◆ GetConstitutiveMatrix1()

ConstitutiveLaw::VoigtSizeMatrixType& Kratos::Python::GetConstitutiveMatrix1 ( ConstitutiveLaw::Parameters rThisParameters)

◆ GetConstitutiveMatrix2()

ConstitutiveLaw::VoigtSizeMatrixType& Kratos::Python::GetConstitutiveMatrix2 ( ConstitutiveLaw::Parameters rThisParameters,
ConstitutiveLaw::VoigtSizeMatrixType C 
)

◆ getDataCommunicator()

const DataCommunicator& Kratos::Python::getDataCommunicator ( pybind11::kwargs  kwargs)

◆ GetDeformationGradientF1()

const ConstitutiveLaw::DeformationGradientMatrixType& Kratos::Python::GetDeformationGradientF1 ( ConstitutiveLaw::Parameters rThisParameters)

◆ GetDeformationGradientF2()

◆ GetDeterminantF1()

double Kratos::Python::GetDeterminantF1 ( ConstitutiveLaw::Parameters rThisParameters)

◆ GetFeaturesOptions()

Flags Kratos::Python::GetFeaturesOptions ( ConstitutiveLaw::Features rThisFeatures)

◆ GetFlag()

Flags Kratos::Python::GetFlag ( Kernel rKernel,
const std::string &  flag_name 
)

◆ GetGeometryFromObject()

template<class T >
const GeometryType& Kratos::Python::GetGeometryFromObject ( T &  rObject)

◆ GetIntegrationPointsFromElement()

py::list Kratos::Python::GetIntegrationPointsFromElement ( Element dummy)

◆ GetLawOptions()

Flags Kratos::Python::GetLawOptions ( ConstitutiveLaw::Parameters rThisParameters)

◆ GetMatRef()

CompressedMatrix& Kratos::Python::GetMatRef ( Kratos::shared_ptr< CompressedMatrix > &  dummy)

◆ GetModelPartName()

const std::string Kratos::Python::GetModelPartName ( ModelPart const &  rModelPart)

◆ GetNodeFromCondition()

NodeType::Pointer Kratos::Python::GetNodeFromCondition ( Condition dummy,
unsigned int  index 
)

◆ GetNodeFromElement()

NodeType::Pointer Kratos::Python::GetNodeFromElement ( Element dummy,
unsigned int  index 
)

◆ GetNodesFromCondition()

py::list Kratos::Python::GetNodesFromCondition ( Condition dummy)

◆ GetNodesFromElement()

py::list Kratos::Python::GetNodesFromElement ( Element dummy)

◆ GetNonHistoricalVariablesNames()

template<class TContainerType >
const std::unordered_set<std::string> Kratos::Python::GetNonHistoricalVariablesNames ( ModelPart rModelPart,
TContainerType &  rContainer,
bool  doFullSearch = false 
)

Retrieve the variable names of the entities in the given container.

Retrieve the variable names of the entities in rContainer. If the doFullSearch is enabled, it will iterate and check all the entities in the container. If not enabled it will be assumed that first entity of the container is representative of the list of variables in every intenty

◆ GetPoints()

PointerVector< Node >& Kratos::Python::GetPoints ( GeometryType geom)

◆ GetProcessInfo()

ProcessInfo& Kratos::Python::GetProcessInfo ( ModelPart rModelPart)

◆ GetPropertiesFromCondition()

Properties::Pointer Kratos::Python::GetPropertiesFromCondition ( Condition pcond)

◆ GetPropertiesFromElement()

Properties::Pointer Kratos::Python::GetPropertiesFromElement ( Element pelem)

◆ GetRegisteredNameCondition()

std::string Kratos::Python::GetRegisteredNameCondition ( const Condition rCondition)

◆ GetRegisteredNameElement()

std::string Kratos::Python::GetRegisteredNameElement ( const Element rElement)

◆ GetSortedListOfFileNameDataHelper()

pybind11::list Kratos::Python::GetSortedListOfFileNameDataHelper ( std::vector< FileNameDataCollector::FileNameData > &  rFileNameDataList,
const std::vector< std::string > &  rSortingFlagsOrder 
)

A thin wrapper for GetSortedListOfFileNameData. The reason for having the wrapper is to replace the original lambda implementation as it causes gcc 4.8 to generate bad code on Centos7 which leads to memory corruption.

◆ GetSpaceDimensionFeatures()

SizeType Kratos::Python::GetSpaceDimensionFeatures ( ConstitutiveLaw::Features rThisFeatures)

◆ GetStrainMeasuresFeatures()

std::vector<ConstitutiveLaw::StrainMeasure>& Kratos::Python::GetStrainMeasuresFeatures ( ConstitutiveLaw::Features rThisFeatures)

◆ GetStrainSizeFeatures()

SizeType Kratos::Python::GetStrainSizeFeatures ( ConstitutiveLaw::Features rThisFeatures)

◆ GetStrainVector1()

ConstitutiveLaw::StrainVectorType& Kratos::Python::GetStrainVector1 ( ConstitutiveLaw::Parameters rThisParameters)

◆ GetStrainVector2()

ConstitutiveLaw::StrainVectorType& Kratos::Python::GetStrainVector2 ( ConstitutiveLaw::Parameters rThisParameters,
ConstitutiveLaw::StrainVectorType strain 
)

◆ GetStressVector1()

ConstitutiveLaw::StressVectorType& Kratos::Python::GetStressVector1 ( ConstitutiveLaw::Parameters rThisParameters)

◆ GetStressVector2()

ConstitutiveLaw::StressVectorType& Kratos::Python::GetStressVector2 ( ConstitutiveLaw::Parameters rThisParameters,
ConstitutiveLaw::StressVectorType stress 
)

◆ GetSubModelPartBegin()

const ModelPart::SubModelPartIterator Kratos::Python::GetSubModelPartBegin ( ModelPart rModelPart)

◆ GetSubModelPartEnd()

const ModelPart::SubModelPartIterator Kratos::Python::GetSubModelPartEnd ( ModelPart rModelPart)

◆ GetSubProperties1()

Properties::Pointer Kratos::Python::GetSubProperties1 ( Properties rProperties,
IndexType  Index 
)

◆ GetSubPropertiesArray1()

PropertiesContainerType& Kratos::Python::GetSubPropertiesArray1 ( Properties rProperties)

◆ GetSubPropertiesArray2()

PropertiesContainerType const& Kratos::Python::GetSubPropertiesArray2 ( const Properties rProperties)

◆ GetTableHelperFunction1()

template<class TContainerType , class XVariableType , class YVariableType >
Properties::TableType& Kratos::Python::GetTableHelperFunction1 ( TContainerType &  rContainer,
const XVariableType &  XVar,
const YVariableType &  YVar 
)

◆ GetThresholdVariable()

const Variable<double>& Kratos::Python::GetThresholdVariable ( MesherUtilities::RefiningParameters rRefiningParameters)

◆ GetValue()

Parameters Kratos::Python::GetValue ( Parameters rParameters,
const std::string &  rEntry 
)

◆ GetValueHelperFunction()

template<class TContainerType , class TVariableType >
TVariableType::Type Kratos::Python::GetValueHelperFunction ( TContainerType &  el,
const TVariableType &  rVar 
)

◆ GetValueHelperFunction1()

template<class TContainerType , class TVariableType >
TVariableType::Type Kratos::Python::GetValueHelperFunction1 ( TContainerType &  rContainer,
const TVariableType &  rVar 
)

◆ GetValueHelperFunctionMasterSlaveConstraint()

template<class TVariableType >
TVariableType::Type Kratos::Python::GetValueHelperFunctionMasterSlaveConstraint ( MasterSlaveConstraint el,
const TVariableType &  rVar 
)

◆ GetValuesOnIntegrationPoints()

template<class TObject >
void Kratos::Python::GetValuesOnIntegrationPoints ( TObject &  dummy,
const Variable< Vector > &  rVariable,
const ProcessInfo rCurrentProcessInfo 
)

◆ GetVariable()

template<class TVariableType >
const TVariableType& Kratos::Python::GetVariable ( Kernel rKernel,
const std::string &  variable_name 
)

◆ GetVariableNames()

template<class TVariableType >
std::string Kratos::Python::GetVariableNames ( Kernel rKernel)

◆ GetVecRef()

Vector& Kratos::Python::GetVecRef ( Kratos::shared_ptr< Vector > &  dummy)

◆ HasConstitutiveLaw()

bool Kratos::Python::HasConstitutiveLaw ( Kernel rKernel,
const std::string &  constitutive_law_name 
)

◆ HasFlag()

bool Kratos::Python::HasFlag ( Kernel rKernel,
const std::string &  flag_name 
)

◆ HasHelperFunction()

template<class TContainerType , class TVariableType >
bool Kratos::Python::HasHelperFunction ( TContainerType &  el,
const TVariableType &  rVar 
)

◆ HasHelperFunctionMasterSlaveConstraint()

template<class TVariableType >
bool Kratos::Python::HasHelperFunctionMasterSlaveConstraint ( MasterSlaveConstraint el,
const TVariableType &  rVar 
)

◆ HasNodalSolutionStepVariable()

template<class TDataType >
bool Kratos::Python::HasNodalSolutionStepVariable ( ModelPart rModelPart,
Variable< TDataType > const &  rThisVariable 
)

◆ HasSubProperties1()

bool Kratos::Python::HasSubProperties1 ( Properties rProperties,
IndexType  Index 
)

◆ HasTableHelperFunction1()

template<class TContainerType , class XVariableType , class YVariableType >
bool Kratos::Python::HasTableHelperFunction1 ( TContainerType &  rContainer,
const XVariableType &  XVar,
const YVariableType &  YVar 
)

◆ HasVariable()

template<class TVariableType >
bool Kratos::Python::HasVariable ( Kernel rKernel,
const std::string &  variable_name 
)

◆ Hello()

std::string Kratos::Python::Hello ( )

◆ Helper_SetCrossSectionsOnIntegrationPoints_Thick()

void Kratos::Python::Helper_SetCrossSectionsOnIntegrationPoints_Thick ( ShellThickElement3D4N el,
const pybind11::list &  seclist 
)

◆ Helper_SetCrossSectionsOnIntegrationPoints_Thin()

void Kratos::Python::Helper_SetCrossSectionsOnIntegrationPoints_Thin ( ShellThinElement3D3N el,
const pybind11::list &  seclist 
)

◆ IndexingUtility()

template<class TBinderType , typename TContainerType , typename TVariableType >
void Kratos::Python::IndexingUtility ( TBinderType &  binder)

◆ InitializeMPIParallelRun()

void Kratos::Python::InitializeMPIParallelRun ( )

◆ InitializeSolutionStep()

void Kratos::Python::InitializeSolutionStep ( ConstructionUtility rThisUtil,
std::string  ThermalSubModelPartName,
std::string  MechanicalSubModelPartName,
std::string  HeatFluxSubModelPartName,
std::string  HydraulicPressureSubModelPartName,
bool  thermal_conditions,
bool  mechanical_conditions,
int  phase 
)
inline

◆ InterpolateDiscontinuousMeshVariableToSkinArray()

template<std::size_t TDim>
void Kratos::Python::InterpolateDiscontinuousMeshVariableToSkinArray ( EmbeddedSkinUtility< TDim > &  rEmbeddedSkinUtility,
const Variable< array_1d< double, 3 >> &  rVariable,
const Variable< array_1d< double, 3 >> &  rEmbeddedVariable,
const std::string &  rInterfaceSide 
)

◆ InterpolateDiscontinuousMeshVariableToSkinDouble()

template<std::size_t TDim>
void Kratos::Python::InterpolateDiscontinuousMeshVariableToSkinDouble ( EmbeddedSkinUtility< TDim > &  rEmbeddedSkinUtility,
const Variable< double > &  rVariable,
const Variable< double > &  rEmbeddedVariable,
const std::string &  rInterfaceSide 
)

◆ InterpolateMeshVariableToSkinArray()

template<std::size_t TDim>
void Kratos::Python::InterpolateMeshVariableToSkinArray ( EmbeddedSkinUtility< TDim > &  rEmbeddedSkinUtility,
const Variable< array_1d< double, 3 >> &  rVariable,
const Variable< array_1d< double, 3 >> &  rEmbeddedVariable 
)

◆ InterpolateMeshVariableToSkinDouble()

template<std::size_t TDim>
void Kratos::Python::InterpolateMeshVariableToSkinDouble ( EmbeddedSkinUtility< TDim > &  rEmbeddedSkinUtility,
const Variable< double > &  rVariable,
const Variable< double > &  rEmbeddedVariable 
)

◆ InverseMapScalar()

template<typename TMapper >
void Kratos::Python::InverseMapScalar ( TMapper &  mapper,
const Variable< double > &  origin_variable,
const Variable< double > &  destination_variable 
)
inline

◆ InverseMapVector()

template<typename TMapper >
void Kratos::Python::InverseMapVector ( TMapper &  mapper,
const Variable< array_1d< double, 3 > > &  origin_variable,
const Variable< array_1d< double, 3 > > &  destination_variable 
)
inline

◆ IsIdGeneratedFromString1()

bool Kratos::Python::IsIdGeneratedFromString1 ( GeometryType dummy)

◆ IsIdSelfAssigned1()

bool Kratos::Python::IsIdSelfAssigned1 ( GeometryType dummy)

◆ isPrintingRank()

bool Kratos::Python::isPrintingRank ( pybind11::kwargs  kwargs)

◆ items()

pybind11::list Kratos::Python::items ( Parameters const &  self)

◆ keys()

pybind11::list Kratos::Python::keys ( Parameters const &  self)

◆ ListOfAllTestCases()

void Kratos::Python::ListOfAllTestCases ( )

◆ MakeNumpyArray()

template<class TDataType >
pybind11::array_t<TDataType> Kratos::Python::MakeNumpyArray ( TDataType const *  pBegin,
TDataType const *  pEnd,
const std::vector< std::size_t > &  rShape 
)

◆ MapScalar()

template<typename TMapper >
void Kratos::Python::MapScalar ( TMapper &  mapper,
const Variable< double > &  origin_variable,
const Variable< double > &  destination_variable 
)
inline

◆ MapVector()

template<typename TMapper >
void Kratos::Python::MapVector ( TMapper &  mapper,
const Variable< array_1d< double, 3 > > &  origin_variable,
const Variable< array_1d< double, 3 > > &  destination_variable 
)
inline

◆ MatrixPrintOnGaussPoints()

void Kratos::Python::MatrixPrintOnGaussPoints ( GidIOType dummy,
const Variable< Matrix > &  rVariable,
ModelPart r_model_part,
double  SolutionTag 
)

◆ Model_GetModelPart()

ModelPart& Kratos::Python::Model_GetModelPart ( Model rModel,
const std::string &  rFullModelPartName 
)

◆ ModelPartAddCondition1()

void Kratos::Python::ModelPartAddCondition1 ( ModelPart rModelPart,
Condition::Pointer  newCondition 
)

◆ ModelPartAddCondition2()

void Kratos::Python::ModelPartAddCondition2 ( ModelPart rModelPart,
Condition::Pointer  newCondition,
unsigned int  ThisIndex 
)

◆ ModelPartAddGeometry1()

void Kratos::Python::ModelPartAddGeometry1 ( ModelPart rModelPart,
ModelPart::GeometryType::Pointer  pNewGeometry 
)

◆ ModelPartAddMasterSlaveConstraint()

void Kratos::Python::ModelPartAddMasterSlaveConstraint ( ModelPart rModelPart,
ModelPart::MasterSlaveConstraintType::Pointer  pMasterSlaveConstraint 
)

◆ ModelPartCreateNewCondition()

Condition::Pointer Kratos::Python::ModelPartCreateNewCondition ( ModelPart rModelPart,
const std::string  ConditionName,
ModelPart::IndexType  Id,
std::vector< ModelPart::IndexType > &  NodeIdList,
ModelPart::PropertiesType::Pointer  pProperties 
)

◆ ModelPartCreateNewElement()

Element::Pointer Kratos::Python::ModelPartCreateNewElement ( ModelPart rModelPart,
const std::string  ElementName,
ModelPart::IndexType  Id,
std::vector< ModelPart::IndexType > &  NodeIdList,
ModelPart::PropertiesType::Pointer  pProperties 
)

◆ ModelPartCreateNewGeometry1()

Geometry<Node>::Pointer Kratos::Python::ModelPartCreateNewGeometry1 ( ModelPart rModelPart,
const std::string &  GeometryTypeName,
std::vector< ModelPart::IndexType > &  NodeIdList 
)

◆ ModelPartCreateNewGeometry2()

Geometry<Node>::Pointer Kratos::Python::ModelPartCreateNewGeometry2 ( ModelPart rModelPart,
const std::string &  GeometryTypeName,
ModelPart::IndexType  GeometryId,
std::vector< ModelPart::IndexType > &  NodeIdList 
)

◆ ModelPartCreateNewGeometry3()

Geometry<Node>::Pointer Kratos::Python::ModelPartCreateNewGeometry3 ( ModelPart rModelPart,
const std::string &  GeometryTypeName,
const std::string &  GeometryIdentifierName,
std::vector< ModelPart::IndexType > &  NodeIdList 
)

◆ ModelPartCreateNewGeometry4()

Geometry<Node>::Pointer Kratos::Python::ModelPartCreateNewGeometry4 ( ModelPart rModelPart,
const std::string &  GeometryTypeName,
ModelPart::GeometryType::Pointer  pGeometry 
)

◆ ModelPartCreateNewGeometry5()

Geometry<Node>::Pointer Kratos::Python::ModelPartCreateNewGeometry5 ( ModelPart rModelPart,
const std::string &  GeometryTypeName,
ModelPart::IndexType  GeometryId,
ModelPart::GeometryType::Pointer  pGeometry 
)

◆ ModelPartCreateNewGeometry6()

Geometry<Node>::Pointer Kratos::Python::ModelPartCreateNewGeometry6 ( ModelPart rModelPart,
const std::string &  GeometryTypeName,
const std::string &  GeometryIdentifierName,
ModelPart::GeometryType::Pointer  pGeometry 
)

◆ ModelPartCreateNewNode()

Node ::Pointer Kratos::Python::ModelPartCreateNewNode ( ModelPart rModelPart,
int  Id,
double  x,
double  y,
double  z 
)

◆ ModelPartGetCommunicator()

Communicator& Kratos::Python::ModelPartGetCommunicator ( ModelPart rModelPart)

◆ ModelPartGetCondition1()

ModelPart::ConditionType::Pointer Kratos::Python::ModelPartGetCondition1 ( ModelPart rModelPart,
ModelPart::IndexType  ConditionId 
)

◆ ModelPartGetCondition2()

ModelPart::ConditionType::Pointer Kratos::Python::ModelPartGetCondition2 ( ModelPart rModelPart,
ModelPart::IndexType  ConditionId,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartGetConditions1()

ModelPart::ConditionsContainerType::Pointer Kratos::Python::ModelPartGetConditions1 ( ModelPart rModelPart)

◆ ModelPartGetConditions2()

ModelPart::ConditionsContainerType::Pointer Kratos::Python::ModelPartGetConditions2 ( ModelPart rModelPart,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartGetElement1()

ModelPart::ElementType::Pointer Kratos::Python::ModelPartGetElement1 ( ModelPart rModelPart,
ModelPart::IndexType  ElementId 
)

◆ ModelPartGetElement2()

ModelPart::ElementType::Pointer Kratos::Python::ModelPartGetElement2 ( ModelPart rModelPart,
ModelPart::IndexType  ElementId,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartGetElements1()

ModelPart::ElementsContainerType::Pointer Kratos::Python::ModelPartGetElements1 ( ModelPart rModelPart)

◆ ModelPartGetElements2()

ModelPart::ElementsContainerType::Pointer Kratos::Python::ModelPartGetElements2 ( ModelPart rModelPart,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartGetGeometry1()

ModelPart::GeometryType::Pointer Kratos::Python::ModelPartGetGeometry1 ( ModelPart rModelPart,
ModelPart::IndexType  GeometryId 
)

◆ ModelPartGetGeometry2()

ModelPart::GeometryType::Pointer Kratos::Python::ModelPartGetGeometry2 ( ModelPart rModelPart,
const std::string &  GeometryName 
)

◆ ModelPartGetMasterSlaveConstraint1()

ModelPart::MasterSlaveConstraintType::Pointer Kratos::Python::ModelPartGetMasterSlaveConstraint1 ( ModelPart rModelPart,
ModelPart::IndexType  MasterSlaveConstraintId 
)

◆ ModelPartGetMasterSlaveConstraints1()

const ModelPart::MasterSlaveConstraintContainerType& Kratos::Python::ModelPartGetMasterSlaveConstraints1 ( ModelPart rModelPart)

◆ ModelPartGetMesh()

ModelPart::MeshType::Pointer Kratos::Python::ModelPartGetMesh ( ModelPart rModelPart)

◆ ModelPartGetMesh2()

ModelPart::MeshType::Pointer Kratos::Python::ModelPartGetMesh2 ( ModelPart rModelPart,
ModelPart::IndexType  MeshIndex 
)

◆ ModelPartGetNode1()

ModelPart::NodeType::Pointer Kratos::Python::ModelPartGetNode1 ( ModelPart rModelPart,
ModelPart::IndexType  NodeId 
)

◆ ModelPartGetNode2()

ModelPart::NodeType::Pointer Kratos::Python::ModelPartGetNode2 ( ModelPart rModelPart,
ModelPart::IndexType  NodeId,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartGetNodes1()

ModelPart::NodesContainerType::Pointer Kratos::Python::ModelPartGetNodes1 ( ModelPart rModelPart)

◆ ModelPartGetNodes2()

ModelPart::NodesContainerType::Pointer Kratos::Python::ModelPartGetNodes2 ( ModelPart rModelPart,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartGetPropertiesContainer()

ModelPart::PropertiesContainerType::Pointer Kratos::Python::ModelPartGetPropertiesContainer ( ModelPart rModelPart)

◆ ModelPartHasCondition1()

bool Kratos::Python::ModelPartHasCondition1 ( ModelPart rModelPart,
ModelPart::IndexType  ConditionId 
)

◆ ModelPartHasCondition2()

bool Kratos::Python::ModelPartHasCondition2 ( ModelPart rModelPart,
ModelPart::IndexType  ConditionId,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartHasElement1()

bool Kratos::Python::ModelPartHasElement1 ( ModelPart rModelPart,
ModelPart::IndexType  ElementId 
)

◆ ModelPartHasElement2()

bool Kratos::Python::ModelPartHasElement2 ( ModelPart rModelPart,
ModelPart::IndexType  ElementId,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartHasGeometry1()

bool Kratos::Python::ModelPartHasGeometry1 ( ModelPart rModelPart,
ModelPart::IndexType  GeometryId 
)

◆ ModelPartHasGeometry2()

bool Kratos::Python::ModelPartHasGeometry2 ( ModelPart rModelPart,
const std::string &  GeometryName 
)

◆ ModelPartHasNodalVariableOrNot()

template<class TDataType >
bool Kratos::Python::ModelPartHasNodalVariableOrNot ( VariableChecker rChecker,
ModelPart rModelPart,
Variable< TDataType > const &  rThisVariable 
)

◆ ModelPartHasNode1()

bool Kratos::Python::ModelPartHasNode1 ( ModelPart rModelPart,
ModelPart::IndexType  NodeId 
)

◆ ModelPartHasNode2()

bool Kratos::Python::ModelPartHasNode2 ( ModelPart rModelPart,
ModelPart::IndexType  NodeId,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartNumberOfConditions1()

ModelPart::SizeType Kratos::Python::ModelPartNumberOfConditions1 ( ModelPart rModelPart)

◆ ModelPartNumberOfElements1()

ModelPart::SizeType Kratos::Python::ModelPartNumberOfElements1 ( ModelPart rModelPart)

◆ ModelPartNumberOfMasterSlaveConstraints1()

ModelPart::SizeType Kratos::Python::ModelPartNumberOfMasterSlaveConstraints1 ( ModelPart rModelPart)

◆ ModelPartNumberOfNodes1()

ModelPart::SizeType Kratos::Python::ModelPartNumberOfNodes1 ( ModelPart rModelPart)

◆ ModelPartRemoveCondition1()

void Kratos::Python::ModelPartRemoveCondition1 ( ModelPart rModelPart,
ModelPart::IndexType  ConditionId 
)

◆ ModelPartRemoveCondition2()

void Kratos::Python::ModelPartRemoveCondition2 ( ModelPart rModelPart,
ModelPart::IndexType  ConditionId,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartRemoveCondition3()

void Kratos::Python::ModelPartRemoveCondition3 ( ModelPart rModelPart,
ModelPart::ConditionType::Pointer  pThisCondition 
)

◆ ModelPartRemoveCondition4()

void Kratos::Python::ModelPartRemoveCondition4 ( ModelPart rModelPart,
ModelPart::ConditionType::Pointer  pThisCondition,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartRemoveConditionFromAllLevels1()

void Kratos::Python::ModelPartRemoveConditionFromAllLevels1 ( ModelPart rModelPart,
ModelPart::IndexType  ConditionId 
)

◆ ModelPartRemoveConditionFromAllLevels2()

void Kratos::Python::ModelPartRemoveConditionFromAllLevels2 ( ModelPart rModelPart,
ModelPart::IndexType  ConditionId,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartRemoveConditionFromAllLevels3()

void Kratos::Python::ModelPartRemoveConditionFromAllLevels3 ( ModelPart rModelPart,
ModelPart::ConditionType::Pointer  pThisCondition 
)

◆ ModelPartRemoveConditionFromAllLevels4()

void Kratos::Python::ModelPartRemoveConditionFromAllLevels4 ( ModelPart rModelPart,
ModelPart::ConditionType::Pointer  pThisCondition,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartRemoveConditionsFromAllLevels()

void Kratos::Python::ModelPartRemoveConditionsFromAllLevels ( ModelPart rModelPart,
Flags  identifier_flag 
)

◆ ModelPartRemoveElement1()

void Kratos::Python::ModelPartRemoveElement1 ( ModelPart rModelPart,
ModelPart::IndexType  ElementId 
)

◆ ModelPartRemoveElement2()

void Kratos::Python::ModelPartRemoveElement2 ( ModelPart rModelPart,
ModelPart::IndexType  ElementId,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartRemoveElement3()

void Kratos::Python::ModelPartRemoveElement3 ( ModelPart rModelPart,
ModelPart::ElementType::Pointer  pThisElement 
)

◆ ModelPartRemoveElement4()

void Kratos::Python::ModelPartRemoveElement4 ( ModelPart rModelPart,
ModelPart::ElementType::Pointer  pThisElement,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartRemoveElementFromAllLevels1()

void Kratos::Python::ModelPartRemoveElementFromAllLevels1 ( ModelPart rModelPart,
ModelPart::IndexType  ElementId 
)

◆ ModelPartRemoveElementFromAllLevels2()

void Kratos::Python::ModelPartRemoveElementFromAllLevels2 ( ModelPart rModelPart,
ModelPart::IndexType  ElementId,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartRemoveElementFromAllLevels3()

void Kratos::Python::ModelPartRemoveElementFromAllLevels3 ( ModelPart rModelPart,
ModelPart::ElementType::Pointer  pThisElement 
)

◆ ModelPartRemoveElementFromAllLevels4()

void Kratos::Python::ModelPartRemoveElementFromAllLevels4 ( ModelPart rModelPart,
ModelPart::ElementType::Pointer  pThisElement,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartRemoveElementsFromAllLevels()

void Kratos::Python::ModelPartRemoveElementsFromAllLevels ( ModelPart rModelPart,
Flags  identifier_flag 
)

◆ ModelPartRemoveGeometry1()

void Kratos::Python::ModelPartRemoveGeometry1 ( ModelPart rModelPart,
ModelPart::IndexType  GeometryId 
)

◆ ModelPartRemoveGeometry2()

void Kratos::Python::ModelPartRemoveGeometry2 ( ModelPart rModelPart,
const std::string &  GeometryName 
)

◆ ModelPartRemoveGeometryFromAllLevels1()

void Kratos::Python::ModelPartRemoveGeometryFromAllLevels1 ( ModelPart rModelPart,
ModelPart::IndexType  GeometryId 
)

◆ ModelPartRemoveGeometryFromAllLevels2()

void Kratos::Python::ModelPartRemoveGeometryFromAllLevels2 ( ModelPart rModelPart,
const std::string &  GeometryName 
)

◆ ModelPartRemoveMasterSlaveConstraint1()

void Kratos::Python::ModelPartRemoveMasterSlaveConstraint1 ( ModelPart rModelPart,
ModelPart::IndexType  MasterSlaveConstraintId 
)

◆ ModelPartRemoveMasterSlaveConstraint2()

void Kratos::Python::ModelPartRemoveMasterSlaveConstraint2 ( ModelPart rModelPart,
ModelPart::MasterSlaveConstraintType rOtherMasterSlaveConstraint 
)

◆ ModelPartRemoveMasterSlaveConstraintFromAllLevels1()

void Kratos::Python::ModelPartRemoveMasterSlaveConstraintFromAllLevels1 ( ModelPart rModelPart,
ModelPart::IndexType  MasterSlaveConstraintId 
)

◆ ModelPartRemoveMasterSlaveConstraintFromAllLevels2()

void Kratos::Python::ModelPartRemoveMasterSlaveConstraintFromAllLevels2 ( ModelPart rModelPart,
ModelPart::MasterSlaveConstraintType rMasterSlaveConstraint 
)

◆ ModelPartRemoveNode1()

void Kratos::Python::ModelPartRemoveNode1 ( ModelPart rModelPart,
ModelPart::IndexType  NodeId 
)

◆ ModelPartRemoveNode2()

void Kratos::Python::ModelPartRemoveNode2 ( ModelPart rModelPart,
ModelPart::IndexType  NodeId,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartRemoveNode3()

void Kratos::Python::ModelPartRemoveNode3 ( ModelPart rModelPart,
ModelPart::NodeType::Pointer  pThisNode 
)

◆ ModelPartRemoveNode4()

void Kratos::Python::ModelPartRemoveNode4 ( ModelPart rModelPart,
ModelPart::NodeType::Pointer  pThisNode,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartRemoveNodeFromAllLevels1()

void Kratos::Python::ModelPartRemoveNodeFromAllLevels1 ( ModelPart rModelPart,
ModelPart::IndexType  NodeId 
)

◆ ModelPartRemoveNodeFromAllLevels2()

void Kratos::Python::ModelPartRemoveNodeFromAllLevels2 ( ModelPart rModelPart,
ModelPart::IndexType  NodeId,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartRemoveNodeFromAllLevels3()

void Kratos::Python::ModelPartRemoveNodeFromAllLevels3 ( ModelPart rModelPart,
ModelPart::NodeType::Pointer  pThisNode 
)

◆ ModelPartRemoveNodeFromAllLevels4()

void Kratos::Python::ModelPartRemoveNodeFromAllLevels4 ( ModelPart rModelPart,
ModelPart::NodeType::Pointer  pThisNode,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartRemoveNodesFromAllLevels()

void Kratos::Python::ModelPartRemoveNodesFromAllLevels ( ModelPart rModelPart,
Flags  identifier_flag 
)

◆ ModelPartSetConditions1()

void Kratos::Python::ModelPartSetConditions1 ( ModelPart rModelPart,
ModelPart::ConditionsContainerType::Pointer  pOtherConditions 
)

◆ ModelPartSetConditions2()

void Kratos::Python::ModelPartSetConditions2 ( ModelPart rModelPart,
ModelPart::ConditionsContainerType::Pointer  pOtherConditions,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartSetElements1()

void Kratos::Python::ModelPartSetElements1 ( ModelPart rModelPart,
ModelPart::ElementsContainerType::Pointer  pOtherElements 
)

◆ ModelPartSetElements2()

void Kratos::Python::ModelPartSetElements2 ( ModelPart rModelPart,
ModelPart::ElementsContainerType::Pointer  pOtherElements,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartSetNodes1()

void Kratos::Python::ModelPartSetNodes1 ( ModelPart rModelPart,
ModelPart::NodesContainerType::Pointer  pOtherNodes 
)

◆ ModelPartSetNodes2()

void Kratos::Python::ModelPartSetNodes2 ( ModelPart rModelPart,
ModelPart::NodesContainerType::Pointer  pOtherNodes,
ModelPart::IndexType  ThisIndex 
)

◆ ModelPartSetPropertiesContainer()

void Kratos::Python::ModelPartSetPropertiesContainer ( ModelPart rModelPart,
ModelPart::PropertiesContainerType::Pointer  pOtherProperties 
)

◆ MountBin1()

template<unsigned int TDim>
void Kratos::Python::MountBin1 ( MoveParticleUtilityScalarTransport< TDim > &  rMoveParticleUtility)

◆ MountBin2()

template<unsigned int TDim>
void Kratos::Python::MountBin2 ( MoveParticleUtilityScalarTransport< TDim > &  rMoveParticleUtility,
const double  CellSize 
)

◆ MoveMesh()

void Kratos::Python::MoveMesh ( Scheme< SparseSpaceType, LocalSpaceType > &  dummy,
ModelPart::NodesContainerType rNodes 
)

◆ Mult()

template<typename TSpaceType >
void Kratos::Python::Mult ( TSpaceType dummy,
typename TSpaceType::MatrixType rA,
typename TSpaceType::VectorType rX,
typename TSpaceType::VectorType rY 
)

◆ NewInterfaceCalculateMaterialResponse()

void Kratos::Python::NewInterfaceCalculateMaterialResponse ( ConstitutiveLaw rThisConstitutiveLaw,
ConstitutiveLaw::Parameters rValues,
const ConstitutiveLaw::StressMeasure rStressMeasure 
)

◆ NodeAddDof()

template<class TVariableType >
void Kratos::Python::NodeAddDof ( Node rThisNode,
TVariableType const &  rThisVariable 
)
inline

◆ NodeAddDofwithReaction()

template<class TVariableType >
void Kratos::Python::NodeAddDofwithReaction ( Node rThisNode,
TVariableType const &  rThisVariable,
TVariableType const &  rReactionVariable 
)
inline

◆ NodeFix()

template<class TVariableType >
void Kratos::Python::NodeFix ( Node rThisNode,
TVariableType const &  rThisVariable 
)
inline

◆ NodeFree()

template<class TVariableType >
void Kratos::Python::NodeFree ( Node rThisNode,
TVariableType const &  rThisVariable 
)
inline

◆ NodeHasDofFor()

template<class TVariableType >
bool Kratos::Python::NodeHasDofFor ( Node rThisNode,
TVariableType const &  rThisVariable 
)
inline

◆ NodeIsFixed()

template<class TVariableType >
bool Kratos::Python::NodeIsFixed ( Node rThisNode,
TVariableType const &  rThisVariable 
)
inline

◆ NodeSolutionStepsDataHas()

template<class TVariableType >
bool Kratos::Python::NodeSolutionStepsDataHas ( Node rThisNode,
const TVariableType &  rThisVariable 
)

◆ PointGetX()

template<class TPointType >
double Kratos::Python::PointGetX ( TPointType &  ThisPoint)
inline

◆ PointGetX0()

double Kratos::Python::PointGetX0 ( Node ThisPoint)

◆ PointGetY()

template<class TPointType >
double Kratos::Python::PointGetY ( TPointType &  ThisPoint)
inline

◆ PointGetY0()

double Kratos::Python::PointGetY0 ( Node ThisPoint)

◆ PointGetZ()

template<class TPointType >
double Kratos::Python::PointGetZ ( TPointType &  ThisPoint)
inline

◆ PointGetZ0()

double Kratos::Python::PointGetZ0 ( Node ThisPoint)

◆ PointSetX()

template<class TPointType >
void Kratos::Python::PointSetX ( TPointType &  ThisPoint,
double  Value 
)
inline

◆ PointSetX0()

void Kratos::Python::PointSetX0 ( Node ThisPoint,
double  Value 
)

◆ PointSetY()

template<class TPointType >
void Kratos::Python::PointSetY ( TPointType &  ThisPoint,
double  Value 
)
inline

◆ PointSetY0()

void Kratos::Python::PointSetY0 ( Node ThisPoint,
double  Value 
)

◆ PointSetZ()

template<class TPointType >
void Kratos::Python::PointSetZ ( TPointType &  ThisPoint,
double  Value 
)
inline

◆ PointSetZ0()

void Kratos::Python::PointSetZ0 ( Node ThisPoint,
double  Value 
)

◆ printDefault()

void Kratos::Python::printDefault ( pybind11::args  args,
pybind11::kwargs  kwargs 
)

Prints the arguments from the python script using the Kratos Logger class. Default function uses INFO severity. @args pybind11::args pybind11::object representing the arguments of the function The first argument is the label @kwargs pybind11::dictionary of pybind11::objects resenting key-value pairs for name arguments

◆ printDefaultOnAllRanks()

void Kratos::Python::printDefaultOnAllRanks ( pybind11::args  args,
pybind11::kwargs  kwargs 
)

◆ printImpl()

void Kratos::Python::printImpl ( pybind11::args  args,
pybind11::kwargs  kwargs,
Logger::Severity  severity,
bool  useKwargLabel,
LoggerMessage::DistributedFilter  filterOption 
)

Prints the arguments from the python script using the Kratos Logger class. Implementation @args tuple representing the arguments of the function The first argument is the label @kwargs dictionary resenting key-value pairs for @severity Logger::Severity The message level of severity

See also
Logger::Severity @useKwargLabel bool Indicates if the label must be gather from kwargs (true) or is the first argument of the call (false) name arguments @printRank bool record the MPI rank in the output message.

◆ printInfo()

void Kratos::Python::printInfo ( pybind11::args  args,
pybind11::kwargs  kwargs 
)

Prints the arguments from the python script using the Kratos Logger class using INFO severity. @args pybind11::args pybind11::object representing the arguments of the function The first argument is the label @kwargs pybind11::dictionary of pybind11::objects resenting key-value pairs for name arguments

◆ printInfoOnAllRanks()

void Kratos::Python::printInfoOnAllRanks ( pybind11::args  args,
pybind11::kwargs  kwargs 
)

◆ PrintTimingInformation()

void Kratos::Python::PrintTimingInformation ( Timer rTimer)

◆ PrintVariablesName()

template<class TVariableType >
void Kratos::Python::PrintVariablesName ( Kernel rKernel)

◆ printWarning()

void Kratos::Python::printWarning ( pybind11::args  args,
pybind11::kwargs  kwargs 
)

Prints the arguments from the python script using the Kratos Logger class using WARNING severity. @args pybind11::args pybind11::object representing the arguments of the function The first argument is the label @kwargs pybind11::dictionary of pybind11::objects resenting key-value pairs for name arguments

◆ printWarningOnAllRanks()

void Kratos::Python::printWarningOnAllRanks ( pybind11::args  args,
pybind11::kwargs  kwargs 
)

◆ ProcessInfoGetPreviousSolutionStepInfo()

ProcessInfo::Pointer Kratos::Python::ProcessInfoGetPreviousSolutionStepInfo ( ProcessInfo rProcessInfo)

◆ ProcessInfoGetPreviousTimeStepInfo()

ProcessInfo::Pointer Kratos::Python::ProcessInfoGetPreviousTimeStepInfo ( ProcessInfo rProcessInfo)

◆ PropertiesHasHelperFunction()

template<class TContainerType , class TVariableType >
bool Kratos::Python::PropertiesHasHelperFunction ( TContainerType &  rProperties,
const TVariableType &  rVar 
)

◆ Push_Back_Bounding_Box()

void Kratos::Python::Push_Back_Bounding_Box ( BoundingBoxContainer ThisBoundingBoxContainer,
BoundingBoxPointer  ThisBoundingBox 
)

◆ Push_Back_Constitutive_Laws()

void Kratos::Python::Push_Back_Constitutive_Laws ( MaterialsContainer ThisMaterialsContainer,
ConstitutiveLawPointer  ThisConstitutiveLaw 
)

◆ Push_Back_Process()

void Kratos::Python::Push_Back_Process ( MesherProcessContainer ThisProcessContainer,
MesherProcessPointer  ThisProcess 
)

◆ PYBIND11_MODULE() [1/5]

Kratos::Python::PYBIND11_MODULE ( Kratos  ,
 
)

◆ PYBIND11_MODULE() [2/5]

Kratos::Python::PYBIND11_MODULE ( KratosCoSimulationMPIExtension  ,
 
)

◆ PYBIND11_MODULE() [3/5]

Kratos::Python::PYBIND11_MODULE ( KratosFluidDynamicsHydraulicsApplication  ,
 
)

◆ PYBIND11_MODULE() [4/5]

Kratos::Python::PYBIND11_MODULE ( KratosMedApplication  ,
 
)

◆ PYBIND11_MODULE() [5/5]

Kratos::Python::PYBIND11_MODULE ( KratosMPI  ,
 
)

◆ QuaternionGetW()

double Kratos::Python::QuaternionGetW ( Quaternion< double > &  ThisQuaternion)

◆ QuaternionGetX()

double Kratos::Python::QuaternionGetX ( Quaternion< double > &  ThisQuaternion)

Sets the current table utility on the process info.

Parameters
rCurrentProcessInfoThe process info

◆ QuaternionGetY()

double Kratos::Python::QuaternionGetY ( Quaternion< double > &  ThisQuaternion)

◆ QuaternionGetZ()

double Kratos::Python::QuaternionGetZ ( Quaternion< double > &  ThisQuaternion)

◆ QuaternionSetW()

void Kratos::Python::QuaternionSetW ( Quaternion< double > &  ThisQuaternion,
double  Value 
)

◆ QuaternionSetX()

void Kratos::Python::QuaternionSetX ( Quaternion< double > &  ThisQuaternion,
double  Value 
)

◆ QuaternionSetY()

void Kratos::Python::QuaternionSetY ( Quaternion< double > &  ThisQuaternion,
double  Value 
)

◆ QuaternionSetZ()

void Kratos::Python::QuaternionSetZ ( Quaternion< double > &  ThisQuaternion,
double  Value 
)

◆ ReadInitialValues1()

void Kratos::Python::ReadInitialValues1 ( IO IO,
IO::NodesContainerType rThisNodes,
IO::ElementsContainerType rThisElements,
IO::ConditionsContainerType rThisConditions 
)

◆ ReadInitialValues2()

void Kratos::Python::ReadInitialValues2 ( IO IO,
ModelPart rThisModelPart 
)

◆ register_base_dense_solver()

void Kratos::Python::register_base_dense_solver ( pybind11::module &  m)

◆ register_dense_eigenvalue_solver()

void Kratos::Python::register_dense_eigenvalue_solver ( pybind11::module &  m,
const std::string &  name 
)

◆ register_dense_solver()

template<typename SolverType >
void Kratos::Python::register_dense_solver ( pybind11::module &  m,
const std::string &  name 
)

◆ register_eigensystem_solver()

void Kratos::Python::register_eigensystem_solver ( pybind11::module &  m,
const std::string &  name 
)

◆ register_feast_eigensystem_solver()

template<typename EigenSystemSolverType >
void Kratos::Python::register_feast_eigensystem_solver ( pybind11::module &  m,
const std::string &  name 
)

◆ register_solver()

template<typename SolverType >
void Kratos::Python::register_solver ( pybind11::module &  m,
const std::string &  name 
)

◆ register_spectra_sym_g_eigs_shift_solver()

void Kratos::Python::register_spectra_sym_g_eigs_shift_solver ( pybind11::module &  m,
const std::string &  name 
)

◆ RegisterAdvancedContactSearchProcess()

template<std::size_t TDim, std::size_t TNumNodes, std::size_t TNumNodesMaster>
void Kratos::Python::RegisterAdvancedContactSearchProcess ( py::module &  m,
const std::string &  rEndName 
)

Registers advanced contact search process.

Parameters
mthe module to register the laws in
rEndNamethe name to append to the law names

◆ RegisterContactSearchProcess()

template<class TClass >
void Kratos::Python::RegisterContactSearchProcess ( py::module &  m,
const std::string &  rName 
)

RegisterContactSearchProcess is a function that registers a contact search process in the given py::module object.

Parameters
mthe py::module object where the contact search process will be registered
rNamethe name of the contact search process

◆ RegisterFrictionalLaws()

template<std::size_t TDim, std::size_t TNumNodes, bool TNormalVariation, std::size_t TNumNodesMaster>
void Kratos::Python::RegisterFrictionalLaws ( py::module &  m,
const std::string &  rEndName 
)

Registers frictional laws in the given module.

Parameters
mthe module to register the laws in
rEndNamethe name to append to the law names

◆ RegisterMPCContactSearchProcess()

template<std::size_t TDim, std::size_t TNumNodes, std::size_t TNumNodesMaster>
void Kratos::Python::RegisterMPCContactSearchProcess ( py::module &  m,
const std::string &  rEndName 
)

Registers MPC contact search process.

Parameters
mthe module to register the laws in
rEndNamethe name to append to the law names

◆ RegisterNormalGapProcess()

template<std::size_t TDim, std::size_t TNumNodes, std::size_t TNumNodesMaster>
void Kratos::Python::RegisterNormalGapProcess ( py::module &  m,
const std::string &  rEndName 
)

Registers the normal gap process.

Parameters
mthe module to register the laws in
rEndNamethe name to append to the law names

◆ RegisterSimpleContactSearchProcess()

template<std::size_t TDim, std::size_t TNumNodes, std::size_t TNumNodesMaster>
void Kratos::Python::RegisterSimpleContactSearchProcess ( py::module &  m,
const std::string &  rEndName 
)

Registers simple contact search process.

Parameters
mthe module to register the laws in
rEndNamethe name to append to the law names

◆ RegisterToPythonApplicationVariables()

void Kratos::Python::RegisterToPythonApplicationVariables ( std::string  ApplicationName)

◆ RemoveSubModelPart1()

void Kratos::Python::RemoveSubModelPart1 ( ModelPart rModelPart,
std::string const &  ThisSubModelPartName 
)

◆ RemoveSubModelPart2()

void Kratos::Python::RemoveSubModelPart2 ( ModelPart rModelPart,
ModelPart ThisSubModelPart 
)

◆ ResizeMatrix()

template<typename TSpaceType >
void Kratos::Python::ResizeMatrix ( TSpaceType dummy,
typename TSpaceType::MatrixType A,
unsigned int  i1,
unsigned int  i2 
)

◆ ResizeVector()

template<typename TSpaceType >
void Kratos::Python::ResizeVector ( TSpaceType dummy,
typename TSpaceType::VectorType x,
unsigned int  i1 
)

◆ ScaleAndAdd()

template<typename TSpaceType >
void Kratos::Python::ScaleAndAdd ( TSpaceType dummy,
const double  A,
const typename TSpaceType::VectorType rX,
const double  B,
typename TSpaceType::VectorType rY 
)

◆ SearchElementAccordingToDimension()

void Kratos::Python::SearchElementAccordingToDimension ( ModelPart rBackgroundGridModelPart,
ModelPart rMPMModelPart,
const std::size_t  MaxNumberOfResults,
const double  Tolerance 
)

◆ SerializerLoad()

template<class TObjectType >
void Kratos::Python::SerializerLoad ( Serializer rSerializer,
std::string const &  rName,
TObjectType &  rObject 
)

◆ SerializerLoadFromBeginning()

template<class TObjectType >
void Kratos::Python::SerializerLoadFromBeginning ( Serializer rSerializer,
std::string const &  rName,
TObjectType &  rObject 
)

◆ SerializerPrint()

void Kratos::Python::SerializerPrint ( Serializer rSerializer)

◆ SerializerSave()

template<class TObjectType >
void Kratos::Python::SerializerSave ( Serializer rSerializer,
std::string const &  rName,
TObjectType &  rObject 
)

◆ SetArray1DVariable()

void Kratos::Python::SetArray1DVariable ( MeshDataTransferUtilities::TransferParameters rTransferParameters,
const Variable< array_1d< double, 3 > > &  rVariable 
)

◆ SetArrayValue()

void Kratos::Python::SetArrayValue ( Properties rProperties,
const Variable< array_1d< double, 3 >> &  rVar,
const std::vector< double > &  rData 
)

◆ SetDoubleVariable()

void Kratos::Python::SetDoubleVariable ( MeshDataTransferUtilities::TransferParameters rTransferParameters,
const Variable< double > &  rVariable 
)

◆ SetErrorVariable()

void Kratos::Python::SetErrorVariable ( MesherUtilities::RefiningParameters rRefiningParameters,
const Variable< double > &  rVariable 
)

◆ SetId1()

void Kratos::Python::SetId1 ( GeometryType dummy,
IndexType  geometry_id 
)

◆ SetId2()

void Kratos::Python::SetId2 ( GeometryType dummy,
const std::string &  geometry_name 
)

◆ SetMatrixVariable()

void Kratos::Python::SetMatrixVariable ( MeshDataTransferUtilities::TransferParameters rTransferParameters,
const Variable< Matrix > &  rVariable 
)

◆ SetModelPartName()

void Kratos::Python::SetModelPartName ( ModelPart rModelPart,
std::string const &  NewName 
)

◆ SetOnProcessInfo()

void Kratos::Python::SetOnProcessInfo ( typename TableStreamUtility::Pointer  pTable,
ProcessInfo rCurrentProcessInfo 
)

Sets the current table utility on the process info.

Parameters
rCurrentProcessInfoThe process info

◆ SetProcessInfo()

void Kratos::Python::SetProcessInfo ( ModelPart rModelPart,
ProcessInfo NewProcessInfo 
)

◆ SetPropertiesFromCondition()

void Kratos::Python::SetPropertiesFromCondition ( Condition pcond,
Properties::Pointer  pProperties 
)

◆ SetPropertiesFromElement()

void Kratos::Python::SetPropertiesFromElement ( Element pelem,
Properties::Pointer  pProperties 
)

◆ SetReferenceCondition()

void Kratos::Python::SetReferenceCondition ( MesherUtilities::MeshingParameters rMeshingParameters,
char *  ConditionName 
)

◆ SetReferenceElement()

void Kratos::Python::SetReferenceElement ( MesherUtilities::MeshingParameters rMeshingParameters,
char *  ElementName 
)

◆ SetRefiningParameters()

void Kratos::Python::SetRefiningParameters ( MesherUtilities::RefiningParameters rRefiningParameters,
double  AlphaParameter,
double  CriticalRadius,
double  CriticalSide 
)

◆ SetTableHelperFunction1()

template<class TContainerType , class XVariableType , class YVariableType >
void Kratos::Python::SetTableHelperFunction1 ( TContainerType &  rContainer,
const XVariableType &  XVar,
const YVariableType &  YVar,
const typename Properties::TableType rData 
)

◆ SetThresholdVariable()

void Kratos::Python::SetThresholdVariable ( MesherUtilities::RefiningParameters rRefiningParameters,
const Variable< double > &  rVariable 
)

◆ SetToZeroMatrix()

template<typename TSpaceType >
void Kratos::Python::SetToZeroMatrix ( TSpaceType dummy,
typename TSpaceType::MatrixType A 
)

◆ SetToZeroVector()

template<typename TSpaceType >
void Kratos::Python::SetToZeroVector ( TSpaceType dummy,
typename TSpaceType::VectorType x 
)

◆ SetValueHelperFunction()

template<class TContainerType , class TVariableType >
void Kratos::Python::SetValueHelperFunction ( TContainerType &  el,
const TVariableType &  rVar,
const typename TVariableType::Type &  Data 
)

◆ SetValueHelperFunction1()

template<class TContainerType , class TVariableType >
void Kratos::Python::SetValueHelperFunction1 ( TContainerType &  rProperties,
const TVariableType &  rVar,
const typename TVariableType::Type &  rData 
)

◆ SetValueHelperFunctionMasterSlaveConstraint()

template<class TVariableType >
void Kratos::Python::SetValueHelperFunctionMasterSlaveConstraint ( MasterSlaveConstraint el,
const TVariableType &  rVar,
const typename TVariableType::Type &  Data 
)

◆ SetValuesOnIntegrationPoints()

template<class TObject , class TDataType >
void Kratos::Python::SetValuesOnIntegrationPoints ( TObject &  dummy,
const Variable< TDataType > &  rVariable,
const std::vector< TDataType > &  values,
const ProcessInfo rCurrentProcessInfo 
)

◆ SetValuesOnIntegrationPointsArray1d()

template<class TObject , std::size_t TSize>
void Kratos::Python::SetValuesOnIntegrationPointsArray1d ( TObject &  dummy,
const Variable< array_1d< double, TSize >> &  rVariable,
pybind11::list  values_list,
const ProcessInfo rCurrentProcessInfo 
)

◆ SetValuesOnIntegrationPointsConstitutiveLaw()

void Kratos::Python::SetValuesOnIntegrationPointsConstitutiveLaw ( Element dummy,
const Variable< ConstitutiveLaw::Pointer > &  rVariable,
pybind11::list  values_list,
const ProcessInfo rCurrentProcessInfo 
)

◆ SetValuesOnIntegrationPointsVector()

template<class TObject >
void Kratos::Python::SetValuesOnIntegrationPointsVector ( TObject &  dummy,
const Variable< Vector > &  rVariable,
pybind11::list  values_list,
unsigned int  len_values_list_item,
const ProcessInfo rCurrentProcessInfo 
)

◆ SetVectorValue()

void Kratos::Python::SetVectorValue ( Properties rProperties,
const Variable< Vector > &  rVar,
const std::vector< double > &  rData 
)

◆ SetVectorVariable()

void Kratos::Python::SetVectorVariable ( MeshDataTransferUtilities::TransferParameters rTransferParameters,
const Variable< Vector > &  rVariable 
)

◆ Size()

template<typename TSpaceType >
TSpaceType::IndexType Kratos::Python::Size ( TSpaceType dummy,
typename TSpaceType::VectorType const &  rV 
)

◆ Size1()

template<typename TSpaceType >
TSpaceType::IndexType Kratos::Python::Size1 ( TSpaceType dummy,
typename TSpaceType::MatrixType const &  rM 
)

◆ Size2()

template<typename TSpaceType >
TSpaceType::IndexType Kratos::Python::Size2 ( TSpaceType dummy,
typename TSpaceType::MatrixType const &  rM 
)

◆ TableGetNearestValue()

double Kratos::Python::TableGetNearestValue ( DoubleTableType ThisTable,
double  X 
)

◆ TetRegeneratePfem3DInc()

void Kratos::Python::TetRegeneratePfem3DInc ( TetGenPfemModeler Mesher,
ModelPart model_part,
double  alpha_shape 
)

◆ TetRegeneratePfemUlf3D()

void Kratos::Python::TetRegeneratePfemUlf3D ( TetGenPfemModeler Mesher,
ModelPart model_part,
double  alpha_shape 
)

◆ TetRegeneratePfemUlf3DInc()

void Kratos::Python::TetRegeneratePfemUlf3DInc ( TetGenPfemModeler Mesher,
ModelPart model_part,
double  alpha_shape 
)

◆ TetRegenerateUpdatedLagrangian()

void Kratos::Python::TetRegenerateUpdatedLagrangian ( TetGenModeler &  Mesher,
ModelPart model_part,
double  alpha_shape 
)

◆ TetRegenerateUpdatedLagrangianInc()

void Kratos::Python::TetRegenerateUpdatedLagrangianInc ( TetGenModeler &  Mesher,
ModelPart model_part,
double  alpha_shape 
)

◆ TransferEigenvector1()

void Kratos::Python::TransferEigenvector1 ( EigenvectorToSolutionStepVariableTransferUtility rThisUtil,
ModelPart rModelPart,
int  iEigenMode 
)
inline

◆ TransferEigenvector2()

void Kratos::Python::TransferEigenvector2 ( EigenvectorToSolutionStepVariableTransferUtility rThisUtil,
ModelPart rModelPart,
int  iEigenMode,
int  step 
)
inline

◆ TransferNodesToElementsOnThreshold()

void Kratos::Python::TransferNodesToElementsOnThreshold ( MeshDataTransferUtilities rMeshDataTransfer,
MeshDataTransferUtilities::TransferParameters rTransferParameters,
MesherUtilities::RefiningParameters rRefiningParameters,
ModelPart rModelPart 
)

◆ TransferSolutionStepData()

void Kratos::Python::TransferSolutionStepData ( ModelPart rFromModelPart,
ModelPart rToModelPart 
)

◆ TransposeMult()

void Kratos::Python::TransposeMult ( SparseSpaceType dummy,
SparseSpaceType::MatrixType rA,
SparseSpaceType::VectorType rX,
SparseSpaceType::VectorType rY 
)

◆ TriRefinePFEM()

void Kratos::Python::TriRefinePFEM ( TriGenCDTrefine &  Mesher,
ModelPart model_part,
bool  refine 
)

◆ TriRegenerate()

void Kratos::Python::TriRegenerate ( TriGenModeler Mesher,
ModelPart model_part,
double  alpha_shape 
)

◆ TriRegenerateCoupled()

void Kratos::Python::TriRegenerateCoupled ( TriGenModeler Mesher,
ModelPart model_part,
double  alpha_shape 
)

◆ TriRegenerateUpdatedLagrangian()

void Kratos::Python::TriRegenerateUpdatedLagrangian ( TriGenModeler Mesher,
ModelPart model_part,
double  alpha_shape 
)

◆ TriRegenerateUpdatedLagrangianTest()

void Kratos::Python::TriRegenerateUpdatedLagrangianTest ( TriGenModeler Mesher,
ModelPart model_part,
double  alpha_shape 
)

◆ TwoNorm()

double Kratos::Python::TwoNorm ( SparseSpaceType dummy,
SparseSpaceType::VectorType x 
)

◆ UnaliasedAdd()

template<typename TSpaceType >
void Kratos::Python::UnaliasedAdd ( TSpaceType dummy,
typename TSpaceType::VectorType x,
const double  A,
const typename TSpaceType::VectorType rY 
)

◆ values()

pybind11::list Kratos::Python::values ( Parameters const &  self)

◆ VariableIndexingUtility()

template<class TBinderType , typename TContainerType , typename TVariableType >
void Kratos::Python::VariableIndexingUtility ( TBinderType &  binder)

◆ VariableUtilsCopyModelPartNodalVar()

template<class TVarType >
void Kratos::Python::VariableUtilsCopyModelPartNodalVar ( VariableUtils rVariableUtils,
const TVarType &  rVariable,
const ModelPart rOriginModelPart,
ModelPart rDestinationModelPart,
const unsigned int  BuffStep = 0 
)

◆ VariableUtilsCopyModelPartNodalVarWithDestination()

template<class TVarType >
void Kratos::Python::VariableUtilsCopyModelPartNodalVarWithDestination ( VariableUtils rVariableUtils,
const TVarType &  rVariable,
const TVarType &  rDestinationVariable,
const ModelPart rOriginModelPart,
ModelPart rDestinationModelPart,
const unsigned int  BuffStep = 0 
)

◆ VariableUtilsSetNonHistoricalVariable()

template<class TDataType , class TContainerType , class TVarType = Variable<TDataType>>
void Kratos::Python::VariableUtilsSetNonHistoricalVariable ( VariableUtils rVariableUtils,
const TVarType &  rVariable,
const TDataType &  rValue,
TContainerType &  rContainer 
)

◆ VariableUtilsSetNonHistoricalVariableForFlag()

template<class TDataType , class TContainerType , class TVarType = Variable<TDataType>>
void Kratos::Python::VariableUtilsSetNonHistoricalVariableForFlag ( VariableUtils rVariableUtils,
const TVarType &  rVariable,
const TDataType &  rValue,
TContainerType &  rContainer,
const Flags  Flag,
const bool  CheckValue = true 
)

◆ VariableUtilsSetVariable()

template<class TDataType , class TVarType = Variable<TDataType>>
void Kratos::Python::VariableUtilsSetVariable ( VariableUtils rVariableUtils,
const TVarType &  rVariable,
const TDataType &  rValue,
ModelPart::NodesContainerType rNodes 
)

Auxiliary set variable export function This function is required to export the SetVariable overloaded method with a unique name.

Template Parameters
TDataTypeThe variable data type
Variable<TDataType>The variable type
Parameters
rVariableUtilsReference to the self variable utils class
rVariableReference to the variable to be set
rValueReference to the value to set
rNodesReference to the nodes container

◆ VariableUtilsSetVariableForFlag()

template<class TDataType , class TVarType = Variable<TDataType>>
void Kratos::Python::VariableUtilsSetVariableForFlag ( VariableUtils rVariableUtils,
const TVarType &  rVariable,
const TDataType &  rValue,
ModelPart::NodesContainerType rNodes,
const Flags  Flag,
const bool  CheckValue = true 
)

Auxiliary set variable export function This function is required to export the SetVariable with flag overloaded method with a unique name.

Template Parameters
TDataTypeThe variable data type
Variable<TDataType>The variable type
Parameters
rVariableUtilsReference to the self variable utils class
rVariableReference to the variable to be set
rValueReference to the value to set
rNodesReference to the nodes container
FlagFlag to filter the nodes that are set
CheckValueFlag value to be checked

◆ VariableUtilsUpdateCurrentPosition()

void Kratos::Python::VariableUtilsUpdateCurrentPosition ( VariableUtils rVariableUtils,
const ModelPart::NodesContainerType rNodes 
)

◆ VariableUtilsUpdateCurrentPositionWithVariable()

void Kratos::Python::VariableUtilsUpdateCurrentPositionWithVariable ( VariableUtils rVariableUtils,
const ModelPart::NodesContainerType rNodes,
const VariableUtils::ArrayVarType rUpdateVariable 
)

◆ VariableUtilsUpdateCurrentPositionWithVariableAndPosition()

void Kratos::Python::VariableUtilsUpdateCurrentPositionWithVariableAndPosition ( VariableUtils rVariableUtils,
const ModelPart::NodesContainerType rNodes,
const VariableUtils::ArrayVarType rUpdateVariable,
const IndexType  BufferPosition 
)

◆ VectorBroadcastWrapper()

template<class TValue >
std::vector<TValue> Kratos::Python::VectorBroadcastWrapper ( const DataCommunicator rSelf,
void(DataCommunicator::*)(std::vector< TValue > &, const int) const  pBroadcastMethod,
const std::vector< TValue > &  rSourceValues,
const int  SourceRank 
)

◆ VectorPrintOnGaussPoints()

void Kratos::Python::VectorPrintOnGaussPoints ( GidIOType dummy,
const Variable< Vector > &  rVariable,
ModelPart r_model_part,
double  SolutionTag 
)

◆ WriteMesh()

void Kratos::Python::WriteMesh ( GidIOType dummy,
GidIOType::MeshType rThisMesh 
)

◆ WriteNodeMesh()

void Kratos::Python::WriteNodeMesh ( GidIOType dummy,
GidIOType::MeshType rThisMesh 
)

Variable Documentation

◆ pointer_to_array1d_write_nodal_results

void(GidIOType::* Kratos::Python::pointer_to_array1d_write_nodal_results) (Variable< array_1d< double, 3 > > const &rVariable, GidIOType::NodesContainerType &rNodes, double SolutionTag, std::size_t SolutionStepNumber) ( Variable< array_1d< double, 3 > > const &  rVariable,
GidIOType::NodesContainerType rNodes,
double  SolutionTag,
std::size_t  SolutionStepNumber 
) = &GidIOType::WriteNodalResults

◆ pointer_to_double_write_nodal_results

void(GidIOType::* Kratos::Python::pointer_to_double_write_nodal_results) (Variable< double > const &rVariable, GidIOType::NodesContainerType &rNodes, double SolutionTag, std::size_t SolutionStepNumber) ( Variable< double > const &  rVariable,
GidIOType::NodesContainerType rNodes,
double  SolutionTag,
std::size_t  SolutionStepNumber 
) = &GidIOType::WriteNodalResults

◆ pointer_to_io_read_properties

void(GidIO<>::* Kratos::Python::pointer_to_io_read_properties) (IO::PropertiesContainerType &rThisProperties) ( IO::PropertiesContainerType rThisProperties) = &IO::ReadProperties

◆ pointer_to_io_read_single_properties

void(GidIO<>::* Kratos::Python::pointer_to_io_read_single_properties) (Properties &rThisProperties) ( Properties rThisProperties) = &IO::ReadProperties