KratosMultiphysics
KRATOS Multiphysics (Kratos) is a framework for building parallel, multi-disciplinary simulation software, aiming at modularity, extensibility, and high performance. Kratos is written in C++, and counts with an extensive Python interface.
Classes | Public Types | Public Member Functions | Protected Member Functions | Protected Attributes | List of all members
Kratos::WaterPressureUtilities Class Reference

#include <water_pressure_utilities.hpp>

Inheritance diagram for Kratos::WaterPressureUtilities:
Collaboration diagram for Kratos::WaterPressureUtilities:

Classes

struct  HydroMechanicalVariables
 

Public Types

typedef Matrix MatrixType
 
typedef Vector VectorType
 
typedef unsigned int IndexType
 
typedef unsigned int SizeType
 
typedef Properties PropertiesType
 
typedef Node NodeType
 
typedef Geometry< NodeTypeGeometryType
 

Public Member Functions

 WaterPressureUtilities ()
 
virtual ~WaterPressureUtilities ()
 
VectorTypeCalculateAndAddHydromechanicalRHS (HydroMechanicalVariables &rVariables, VectorType &rRightHandSide, const VectorType &rBaseClassRHS, const double &rIntegrationWeight)
 
VectorTypeCalculateAndAddStabilization (HydroMechanicalVariables &rVariables, Vector &rRightHandSide, const double &rIntegrationWeight)
 
MatrixTypeCalculateAndAddHydromechanicalLHS (HydroMechanicalVariables &rVariables, MatrixType &rLeftHandSide, const MatrixType &rBaseClassLHS, const double &rIntegrationWeight)
 
MatrixTypeCalculateAndAddStabilizationLHS (HydroMechanicalVariables &rVariables, Matrix &rLeftHandSide, const double &rIntegrationWeight)
 
void GetPermeabilityTensor (const PropertiesType &rProperties, const Matrix &rTotalF, Matrix &rK, const double &rInitial_porosity, const unsigned int &rDimension, const double &rVolume)
 

Protected Member Functions

void GetScalingConstant (double &rScalingConstant, const PropertiesType &pProperties)
 
void GetPermeabilityTensor (const PropertiesType &rProperties, const Matrix &rTotalF, Matrix &rK, const double &rInitial_porosity, const double &rVolume)
 
virtual void GetVoigtSize (const unsigned int &dimension, unsigned int &voigtsize, unsigned int &principal_dimension)
 
doubleCalculateStabilizationFactor (HydroMechanicalVariables &rVariables, double &rAlphaStabilization)
 
virtual double CalculateVolumeChange (const GeometryType &rGeometry, const Vector &rN, const Matrix &rTotalF)
 
VectorTypeCalculateMassBalance_WaterPressurePart (HydroMechanicalVariables &rVariables, VectorType &rLocalRHS, const double &rIntegrationWeight)
 
virtual VectorTypeCalculateMassBalance_AddDisplacementPart (HydroMechanicalVariables &rVariables, VectorType &rLocalRHS, const double &rIntegrationWeight)
 
VectorTypeCalculateWaterInternalForcesContribution (HydroMechanicalVariables &rVariables, VectorType &rRightHandSideVector, const double &rIntegrationWeight)
 
VectorTypeCalculateVolumeForcesContribution (HydroMechanicalVariables &rVariables, VectorType &rRightHandSideVector, const double &rIntegrationWeight)
 
VectorTypeCalculateStabilizationRHS (HydroMechanicalVariables &rVariables, VectorType &rRightHandSideVector, const double &rIntegrationWeight)
 
VectorTypeAddReshapeBaseClassRHS (VectorType &rRightHandSideVector, const VectorType &rBaseClassRHS, const unsigned int &number_of_variables, const unsigned int &number_of_nodes)
 
VectorTypeAddReshapeWaterPressureForces (VectorType &rRightHandSide, const VectorType &rPartialRHS, const unsigned int number_of_variables, const unsigned int number_of_points)
 
VectorTypeAddReshapeWaterInternalForcesContribution (VectorType &rRightHandSideVector, const VectorType &rPartialRHS, const unsigned int number_of_variables, const unsigned int number_of_nodes, const unsigned int dimension)
 
MatrixTypeComputeWaterPressureKuug (HydroMechanicalVariables &rVariables, MatrixType &rLocalLHS, const double &rIntegrationWeight)
 
virtual MatrixTypeComputeWaterPressureKUwP (HydroMechanicalVariables &rVariables, MatrixType &rLocalLHS, const double &rIntegrationWeight)
 
MatrixTypeComputeWaterPressureKwPwP (HydroMechanicalVariables &rVariables, MatrixType &rLocalLHS, const double &rIntegrationWeight)
 
virtual MatrixTypeComputeSolidSkeletonDeformationMatrix (HydroMechanicalVariables &rVariables, MatrixType &rLocalLHS, const double &rIntegrationWeight)
 
MatrixTypeComputeDarcyFlowGeometricTerms (HydroMechanicalVariables &rVariables, MatrixType &rLocalLHS, const double &rIntegrationWeight)
 
virtual MatrixTypeComputeDensityChangeTerm (HydroMechanicalVariables &rVariables, MatrixType &rLocalLHS, const double &rIntegrationWeight)
 
MatrixTypeCalculateStabilizationLHS (HydroMechanicalVariables &rVariables, MatrixType &rLocalLHS, const double &rIntegrationWeight)
 
MatrixTypeAddReshapeBaseClassLHS (MatrixType &rLeftHandSide, const MatrixType &rBaseClassLHS, const unsigned int dimension, const unsigned int number_of_variables, const unsigned int number_of_nodes)
 
virtual MatrixTypeAddReshapeSolidSkeletonDeformationMatrix (MatrixType &rLeftHandSide, const MatrixType &rBaseClassLHS, const unsigned int dimension, const unsigned int number_of_variables, const unsigned int number_of_nodes)
 
MatrixTypeAddReshapeKUU (MatrixType &rLeftHandSide, const MatrixType &rBaseClassLHS, const unsigned int dimension, const unsigned int number_of_variables, const unsigned int number_of_nodes)
 
MatrixTypeAddReshapeKUwP (MatrixType &rLeftHandSide, const MatrixType &rBaseClassLHS, const unsigned int dimension, const unsigned int number_of_variables, const unsigned int number_of_nodes)
 
MatrixTypeAddReshapeKwPwP (MatrixType &rLeftHandSide, const MatrixType &rBaseClassLHS, const unsigned int dimension, const unsigned int number_of_variables, const unsigned int number_of_nodes)
 
MatrixTypeAddReshapeKwPU (MatrixType &rLeftHandSide, const MatrixType &rBaseClassLHS, const unsigned int dimension, const unsigned int number_of_variables, const unsigned int number_of_nodes)
 

Protected Attributes

bool mPPP
 

Member Typedef Documentation

◆ GeometryType

◆ IndexType

◆ MatrixType

◆ NodeType

◆ PropertiesType

◆ SizeType

◆ VectorType

Constructor & Destructor Documentation

◆ WaterPressureUtilities()

Kratos::WaterPressureUtilities::WaterPressureUtilities ( )

◆ ~WaterPressureUtilities()

virtual Kratos::WaterPressureUtilities::~WaterPressureUtilities ( )
inlinevirtual

Member Function Documentation

◆ AddReshapeBaseClassLHS()

Matrix & Kratos::WaterPressureUtilities::AddReshapeBaseClassLHS ( MatrixType rLeftHandSide,
const MatrixType rBaseClassLHS,
const unsigned int  dimension,
const unsigned int  number_of_variables,
const unsigned int  number_of_nodes 
)
protected

◆ AddReshapeBaseClassRHS()

Vector & Kratos::WaterPressureUtilities::AddReshapeBaseClassRHS ( VectorType rRightHandSideVector,
const VectorType rBaseClassRHS,
const unsigned int number_of_variables,
const unsigned int number_of_nodes 
)
protected

◆ AddReshapeKUU()

Matrix & Kratos::WaterPressureUtilities::AddReshapeKUU ( MatrixType rLeftHandSide,
const MatrixType rBaseClassLHS,
const unsigned int  dimension,
const unsigned int  number_of_variables,
const unsigned int  number_of_nodes 
)
protected

◆ AddReshapeKUwP()

Matrix & Kratos::WaterPressureUtilities::AddReshapeKUwP ( MatrixType rLeftHandSide,
const MatrixType rBaseClassLHS,
const unsigned int  dimension,
const unsigned int  number_of_variables,
const unsigned int  number_of_nodes 
)
protected

◆ AddReshapeKwPU()

Matrix & Kratos::WaterPressureUtilities::AddReshapeKwPU ( MatrixType rLeftHandSide,
const MatrixType rBaseClassLHS,
const unsigned int  dimension,
const unsigned int  number_of_variables,
const unsigned int  number_of_nodes 
)
protected

◆ AddReshapeKwPwP()

Matrix & Kratos::WaterPressureUtilities::AddReshapeKwPwP ( MatrixType rLeftHandSide,
const MatrixType rBaseClassLHS,
const unsigned int  dimension,
const unsigned int  number_of_variables,
const unsigned int  number_of_nodes 
)
protected

◆ AddReshapeSolidSkeletonDeformationMatrix()

Matrix & Kratos::WaterPressureUtilities::AddReshapeSolidSkeletonDeformationMatrix ( MatrixType rLeftHandSide,
const MatrixType rBaseClassLHS,
const unsigned int  dimension,
const unsigned int  number_of_variables,
const unsigned int  number_of_nodes 
)
protectedvirtual

◆ AddReshapeWaterInternalForcesContribution()

Vector & Kratos::WaterPressureUtilities::AddReshapeWaterInternalForcesContribution ( VectorType rRightHandSideVector,
const VectorType rPartialRHS,
const unsigned int  number_of_variables,
const unsigned int  number_of_nodes,
const unsigned int  dimension 
)
protected

◆ AddReshapeWaterPressureForces()

Vector & Kratos::WaterPressureUtilities::AddReshapeWaterPressureForces ( VectorType rRightHandSide,
const VectorType rPartialRHS,
const unsigned int  number_of_variables,
const unsigned int  number_of_points 
)
protected

◆ CalculateAndAddHydromechanicalLHS()

Matrix & Kratos::WaterPressureUtilities::CalculateAndAddHydromechanicalLHS ( HydroMechanicalVariables rVariables,
MatrixType rLeftHandSide,
const MatrixType rBaseClassLHS,
const double rIntegrationWeight 
)

◆ CalculateAndAddHydromechanicalRHS()

Vector & Kratos::WaterPressureUtilities::CalculateAndAddHydromechanicalRHS ( HydroMechanicalVariables rVariables,
VectorType rRightHandSide,
const VectorType rBaseClassRHS,
const double rIntegrationWeight 
)

◆ CalculateAndAddStabilization()

Vector & Kratos::WaterPressureUtilities::CalculateAndAddStabilization ( HydroMechanicalVariables rVariables,
Vector rRightHandSide,
const double rIntegrationWeight 
)

◆ CalculateAndAddStabilizationLHS()

Matrix & Kratos::WaterPressureUtilities::CalculateAndAddStabilizationLHS ( HydroMechanicalVariables rVariables,
Matrix rLeftHandSide,
const double rIntegrationWeight 
)

◆ CalculateMassBalance_AddDisplacementPart()

Vector & Kratos::WaterPressureUtilities::CalculateMassBalance_AddDisplacementPart ( HydroMechanicalVariables rVariables,
VectorType rLocalRHS,
const double rIntegrationWeight 
)
protectedvirtual

◆ CalculateMassBalance_WaterPressurePart()

Vector & Kratos::WaterPressureUtilities::CalculateMassBalance_WaterPressurePart ( HydroMechanicalVariables rVariables,
VectorType rLocalRHS,
const double rIntegrationWeight 
)
protected

◆ CalculateStabilizationFactor()

double & Kratos::WaterPressureUtilities::CalculateStabilizationFactor ( HydroMechanicalVariables rVariables,
double rAlphaStabilization 
)
protected

◆ CalculateStabilizationLHS()

Matrix & Kratos::WaterPressureUtilities::CalculateStabilizationLHS ( HydroMechanicalVariables rVariables,
MatrixType rLocalLHS,
const double rIntegrationWeight 
)
protected

◆ CalculateStabilizationRHS()

Vector & Kratos::WaterPressureUtilities::CalculateStabilizationRHS ( HydroMechanicalVariables rVariables,
VectorType rRightHandSideVector,
const double rIntegrationWeight 
)
protected

◆ CalculateVolumeChange()

double Kratos::WaterPressureUtilities::CalculateVolumeChange ( const GeometryType rGeometry,
const Vector rN,
const Matrix rTotalF 
)
protectedvirtual

◆ CalculateVolumeForcesContribution()

Vector & Kratos::WaterPressureUtilities::CalculateVolumeForcesContribution ( HydroMechanicalVariables rVariables,
VectorType rRightHandSideVector,
const double rIntegrationWeight 
)
protected

◆ CalculateWaterInternalForcesContribution()

Vector & Kratos::WaterPressureUtilities::CalculateWaterInternalForcesContribution ( HydroMechanicalVariables rVariables,
VectorType rRightHandSideVector,
const double rIntegrationWeight 
)
protected

◆ ComputeDarcyFlowGeometricTerms()

Matrix & Kratos::WaterPressureUtilities::ComputeDarcyFlowGeometricTerms ( HydroMechanicalVariables rVariables,
MatrixType rLocalLHS,
const double rIntegrationWeight 
)
protected

◆ ComputeDensityChangeTerm()

Matrix & Kratos::WaterPressureUtilities::ComputeDensityChangeTerm ( HydroMechanicalVariables rVariables,
MatrixType rLocalLHS,
const double rIntegrationWeight 
)
protectedvirtual

◆ ComputeSolidSkeletonDeformationMatrix()

Matrix & Kratos::WaterPressureUtilities::ComputeSolidSkeletonDeformationMatrix ( HydroMechanicalVariables rVariables,
MatrixType rLocalLHS,
const double rIntegrationWeight 
)
protectedvirtual

◆ ComputeWaterPressureKuug()

Matrix & Kratos::WaterPressureUtilities::ComputeWaterPressureKuug ( HydroMechanicalVariables rVariables,
MatrixType rLocalLHS,
const double rIntegrationWeight 
)
protected

◆ ComputeWaterPressureKUwP()

Matrix & Kratos::WaterPressureUtilities::ComputeWaterPressureKUwP ( HydroMechanicalVariables rVariables,
MatrixType rLocalLHS,
const double rIntegrationWeight 
)
protectedvirtual

◆ ComputeWaterPressureKwPwP()

Matrix & Kratos::WaterPressureUtilities::ComputeWaterPressureKwPwP ( HydroMechanicalVariables rVariables,
MatrixType rLocalLHS,
const double rIntegrationWeight 
)
protected

◆ GetPermeabilityTensor() [1/2]

void Kratos::WaterPressureUtilities::GetPermeabilityTensor ( const PropertiesType rProperties,
const Matrix rTotalF,
Matrix rK,
const double rInitial_porosity,
const double rVolume 
)
protected

◆ GetPermeabilityTensor() [2/2]

void Kratos::WaterPressureUtilities::GetPermeabilityTensor ( const PropertiesType rProperties,
const Matrix rTotalF,
Matrix rK,
const double rInitial_porosity,
const unsigned int rDimension,
const double rVolume 
)

◆ GetScalingConstant()

void Kratos::WaterPressureUtilities::GetScalingConstant ( double rScalingConstant,
const PropertiesType pProperties 
)
protected

◆ GetVoigtSize()

void Kratos::WaterPressureUtilities::GetVoigtSize ( const unsigned int dimension,
unsigned int voigtsize,
unsigned int principal_dimension 
)
protectedvirtual

Member Data Documentation

◆ mPPP

bool Kratos::WaterPressureUtilities::mPPP
protected

The documentation for this class was generated from the following files: