OOFEM  2.4
OOFEM.org - Object Oriented Finite Element Solver
mdm.C File Reference
#include "mdm.h"
#include "gausspoint.h"
#include "floatmatrix.h"
#include "floatarray.h"
#include "mathfem.h"
#include "Materials/isolinearelasticmaterial.h"
#include "mmaclosestiptransfer.h"
#include "nonlocalmaterialext.h"
#include "microplane.h"
#include "contextioerr.h"
#include "classfactory.h"
#include "dynamicinputrecord.h"
#include "datastream.h"

Go to the source code of this file.

Namespaces

 oofem
 the oofem namespace is to define a context or scope in which all oofem names are defined.
 

Macros

#define LARGE_EXPONENT   50.0
 
#define HUGE_RELATIVE_COMPLIANCE   1.e20
 
#define N(p, q)   t.at(q, p)
 
#define E(p)   fullStrain.at(p)
 
#define Nt(p, q)   t.at(p, q)
 
#define S(p)   stressPDC.at(p)
 
#define MAX_REL_COMPL_TRESHOLD   1.e6
 
#define FORMT33(i, j, ij)   answer.at(ij, 1) = t.at(i, 1) * t.at(j, 1); answer.at(ij, 2) = t.at(i, 2) * t.at(j, 2); answer.at(ij, 3) = t.at(i, 1) * t.at(j, 2) + t.at(i, 2) * t.at(j, 1)
 
#define FORMT44(i, j, ij)   answer.at(ij, 1) = t.at(i, 1) * t.at(j, 1); answer.at(ij, 2) = t.at(i, 2) * t.at(j, 2); answer.at(ij, 3) = t.at(i, 3) * t.at(j, 3); answer.at(ij, 4) = t.at(i, 1) * t.at(j, 2) + t.at(i, 2) * t.at(j, 1)
 
#define FORMT66(i, j, ij)   answer.at(ij, 1) = t.at(i, 1) * t.at(j, 1); answer.at(ij, 2) = t.at(i, 2) * t.at(j, 2); answer.at(ij, 3) = t.at(i, 3) * t.at(j, 3); answer.at(ij, 4) = t.at(i, 2) * t.at(j, 3) + t.at(i, 3) * t.at(j, 2); answer.at(ij, 5) = t.at(i, 1) * t.at(j, 3) + t.at(i, 3) * t.at(j, 1); answer.at(ij, 6) = t.at(i, 1) * t.at(j, 2) + t.at(i, 2) * t.at(j, 1)
 

Functions

 oofem::REGISTER_Material (MDM)
 

Macro Definition Documentation

#define E (   p)    fullStrain.at(p)

Definition at line 368 of file mdm.C.

Referenced by oofem::ConcreteFCM::checkSnapBack(), oofem::ConcreteFCM::computeD2ModulusForCrack(), oofem::FRCFCM::computeD2ModulusForCrack(), oofem::IsotropicDamageMaterial1::computeDamageParamForCohesiveCrack(), oofem::SolidShell::computeEVector(), oofem::M1Material::CreateMicroplaneStatus(), oofem::IsotropicDamageMaterial1::damageFunctionPrime(), oofem::NURBSPlaneStressElement::drawScalar(), oofem::FRCFCM::estimateD2ModulusForCrack(), oofem::EnrFrontLinearBranchFuncOneEl::evaluateEnrFuncDerivAt(), oofem::EnrFrontLinearBranchFuncRadius::evaluateEnrFuncDerivAt(), oofem::EnrFrontCohesiveBranchFuncOneEl::evaluateEnrFuncDerivAt(), oofem::IDGMaterial::give1dGprime(), oofem::MisesMatGrad::give1dKappaMatrix(), oofem::MisesMatGrad::give1dStressStiffMtrx(), oofem::MisesMat::give1dStressStiffMtrx(), oofem::MisesMatNl::give1dStressStiffMtrx(), oofem::SimpleCrossSection::give3dBeamStiffMtrx(), oofem::ConcreteFCM::giveCrackingModulus(), oofem::MaxwellChainMaterial::giveEigenStrainVector(), oofem::MaxwellChainMaterial::giveEModulus(), oofem::StructuralPythonMaterial::giveFirstPKStressVector_3d(), oofem::MisesMat::giveFirstPKStressVector_3d(), oofem::AbaqusUserMaterial::giveFirstPKStressVector_3d(), oofem::StructuralMaterial::giveFirstPKStressVector_3d(), oofem::ConcreteFCM::giveNormalCrackingStress(), oofem::RCSDNLMaterial::giveRealStressVector(), oofem::RCSDEMaterial::giveRealStressVector(), oofem::RCSDMaterial::giveRealStressVector(), oofem::MisesMat::giveRealStressVector_1d(), oofem::ConcreteDPM::giveRealStressVector_3d(), oofem::MisesMatNl::giveRemoteNonlocalStiffnessContribution(), oofem::PrescribedGradientBCWeak::giveType(), oofem::IsotropicDamageMaterial1::initDamaged(), oofem::IsotropicDamageMaterial1::initializeFrom(), oofem::FRCFCM::maxShearStress(), oofem::MisesMat::performPlasticityReturn(), oofem::M1MaterialStatus::restoreContext(), oofem::tet21ghostsolid::tet21ghostsolid(), oofem::Homogenize::~Homogenize(), and oofem::M4Material::~M4Material().

#define FORMT33 (   i,
  j,
  ij 
)    answer.at(ij, 1) = t.at(i, 1) * t.at(j, 1); answer.at(ij, 2) = t.at(i, 2) * t.at(j, 2); answer.at(ij, 3) = t.at(i, 1) * t.at(j, 2) + t.at(i, 2) * t.at(j, 1)

Definition at line 935 of file mdm.C.

Referenced by oofem::MDM::formTransformationMatrix().

#define FORMT44 (   i,
  j,
  ij 
)    answer.at(ij, 1) = t.at(i, 1) * t.at(j, 1); answer.at(ij, 2) = t.at(i, 2) * t.at(j, 2); answer.at(ij, 3) = t.at(i, 3) * t.at(j, 3); answer.at(ij, 4) = t.at(i, 1) * t.at(j, 2) + t.at(i, 2) * t.at(j, 1)

Definition at line 937 of file mdm.C.

Referenced by oofem::MDM::formTransformationMatrix().

#define FORMT66 (   i,
  j,
  ij 
)    answer.at(ij, 1) = t.at(i, 1) * t.at(j, 1); answer.at(ij, 2) = t.at(i, 2) * t.at(j, 2); answer.at(ij, 3) = t.at(i, 3) * t.at(j, 3); answer.at(ij, 4) = t.at(i, 2) * t.at(j, 3) + t.at(i, 3) * t.at(j, 2); answer.at(ij, 5) = t.at(i, 1) * t.at(j, 3) + t.at(i, 3) * t.at(j, 1); answer.at(ij, 6) = t.at(i, 1) * t.at(j, 2) + t.at(i, 2) * t.at(j, 1)

Definition at line 939 of file mdm.C.

Referenced by oofem::MDM::formTransformationMatrix().

#define HUGE_RELATIVE_COMPLIANCE   1.e20

Definition at line 274 of file mdm.C.

Referenced by oofem::MDM::computeDamageOnPlane().

#define LARGE_EXPONENT   50.0

Definition at line 273 of file mdm.C.

Referenced by oofem::MDM::computeDamageOnPlane().

#define MAX_REL_COMPL_TRESHOLD   1.e6

Definition at line 546 of file mdm.C.

Referenced by oofem::MDM::applyDamageToStiffness().

#define N (   p,
 
)    t.at(q, p)

Definition at line 367 of file mdm.C.

Referenced by oofem::PrescribedMean::assemble(), oofem::WeakPeriodicBoundaryCondition::assemble(), oofem::PrescribedGradientBCWeak::assembleTangentGPContributionNew(), oofem::TSplineInterpolation::basisFunction(), oofem::BSplineInterpolation::basisFuns(), oofem::ParticleTopologyDescription::calculateShortestDistance(), oofem::IntElLine1PhF::computeAreaAround(), oofem::IntElLine1::computeAreaAround(), oofem::Q4Axisymm::computeBmatrixAt(), oofem::L4Axisymm::computeBmatrixAt(), oofem::AxisymElement::computeBmatrixAt(), oofem::Shell7Base::computeBmatrixAt(), oofem::TR1_2D_PFEM::computeBodyLoadVectorAt(), oofem::XfemElementInterface::ComputeBOrBHMatrix(), oofem::TransportElement::computeBoundaryEdgeLoadVector(), oofem::Beam2d::computeBoundaryEdgeLoadVector(), oofem::Beam3d::computeBoundaryEdgeLoadVector(), oofem::TransportElement::computeBoundarySurfaceLoadVector(), oofem::Hexa21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tet21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tr21Stokes::computeBoundarySurfaceLoadVector(), oofem::Tr1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::Tet1BubbleStokes::computeBoundarySurfaceLoadVector(), oofem::Shell7Base::computeConvectiveMassForce(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::ConcreteFCM::computeD2ModulusForCrack(), oofem::PFEMElement2d::computeDivergenceMatrix(), oofem::Tr1Darcy::computeEdgeBCSubVectorAt(), oofem::TR1_2D_PFEM::computeEdgeBCSubVectorAt(), oofem::ConcreteFCM::computeEffectiveShearModulus(), oofem::WeakPeriodicBoundaryCondition::computeElementTangent(), oofem::Shell7BaseXFEM::computeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::computeEnrichedNmatrixAt(), oofem::Shell7BaseXFEM::computeEnrTractionForce(), oofem::IsotropicDamageMaterial1::computeEta(), oofem::IntElSurfTr1::computeGlobalCoordinates(), oofem::IntElLine1IntPen::computeGlobalCoordinates(), oofem::Shell7Base::computeGlobalCoordinates(), oofem::StructuralInterfaceElement::computeGlobalCoordinates(), oofem::MITC4Shell::computeGlobalCoordinates(), oofem::PFEMElement2d::computeGradientMatrix(), oofem::Beam2d::computeInitialStressMatrix(), oofem::Beam3d::computeInitialStressMatrix(), oofem::TransportElement::computeInternalForcesVector(), oofem::Tr1BubbleStokes::computeInternalForcesVector(), oofem::Tet1BubbleStokes::computeInternalForcesVector(), oofem::TransportElement::computeLoadVector(), oofem::tet21ghostsolid::computeLoadVector(), oofem::Hexa21Stokes::computeLoadVector(), oofem::Tet21Stokes::computeLoadVector(), oofem::Tr21Stokes::computeLoadVector(), oofem::Tr1BubbleStokes::computeLoadVector(), oofem::Tet1BubbleStokes::computeLoadVector(), oofem::SurfaceTensionBoundaryCondition::computeLoadVectorFromElement(), oofem::Shell7Base::computeMassMatrix(), oofem::Shell7BaseXFEM::computeMassMatrixNum(), oofem::Shell7Base::computeMassMatrixNum(), oofem::FCMMaterial::computeMaxNormalCrackOpening(), oofem::PlaneStressStructuralElementEvaluator::computeNMatrixAt(), oofem::Space3dStructuralElementEvaluator::computeNMatrixAt(), oofem::Tr_Warp::computeNmatrixAt(), oofem::IntElLine2::computeNmatrixAt(), oofem::QDKTPlate::computeNmatrixAt(), oofem::IntElSurfTr1::computeNmatrixAt(), oofem::IntElLine1PhF::computeNmatrixAt(), oofem::DKTPlate::computeNmatrixAt(), oofem::IntElLine1IntPen::computeNmatrixAt(), oofem::IntElLine1::computeNmatrixAt(), oofem::IntElLine1PF::computeNmatrixAt(), oofem::Shell7Base::computeNmatrixAt(), oofem::StructuralElement::computeNmatrixAt(), oofem::FCMMaterial::computeNormalCrackOpening(), oofem::HTSelement::computePrescribedDisplacementLoadVectorAt(), oofem::PFEMElement2d::computePrescribedRhsVector(), oofem::Shell7Base::computePressureForce(), oofem::Shell7Base::computePressureTangentMatrix(), oofem::Shell7BaseXFEM::computePressureTangentMatrixDis(), oofem::FreeWarping::computeResultAtCenterOfGravity(), oofem::Shell7Base::computeSectionalForces(), oofem::StokesFlowVelocityHomogenization::computeSeepage(), oofem::StructuralInterfaceElement::computeSpatialJump(), oofem::HTSelement::computeStiffnessMatrix(), oofem::IntElLine1IntPen::computeStiffnessMatrix(), oofem::IntElLine2IntPen::computeStiffnessMatrix(), oofem::Tr1BubbleStokes::computeStiffnessMatrix(), oofem::Tet1BubbleStokes::computeStiffnessMatrix(), oofem::StructuralInterfaceElement::computeStiffnessMatrix(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_ud(), oofem::IntElLine1PF::computeStiffnessMatrix_ud(), oofem::PhaseFieldElement::computeStiffnessMatrix_uu(), oofem::StructuralInterfaceElementPhF::computeStiffnessMatrix_uu(), oofem::IntElLine1PF::computeStiffnessMatrix_uu(), oofem::CoupledFieldsElement::computeStiffnessMatrixGen(), oofem::Beam3d::computeSubSoilStiffnessMatrix(), oofem::Structural3DElement::computeSurfaceNMatrixAt(), oofem::StokesFlowVelocityHomogenization::computeTangent(), oofem::TransportElement::computeTangentFromEdgeLoad(), oofem::SurfaceTensionBoundaryCondition::computeTangentFromElement(), oofem::TransportElement::computeTangentFromSurfaceLoad(), oofem::Shell7Base::computeTractionForce(), oofem::InteractionLoad::computeValueAt(), oofem::BoundaryLoad::computeValueAt(), oofem::M1Material::CreateMicroplaneStatus(), oofem::drawIGAPatchDeformedGeometry(), oofem::Shell7Base::edgeComputeBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedBmatrixAt(), oofem::Shell7BaseXFEM::edgeComputeEnrichedNmatrixAt(), oofem::Shell7Base::edgeComputeNmatrixAt(), oofem::Shell7Base::edgeEvalInitialDirectorAt(), oofem::FEI3dTrLin::edgeLocal2global(), oofem::FEI3dTetQuad::edgeLocal2global(), oofem::FEI3dTrQuad::edgeLocal2global(), oofem::NURBSInterpolation::evaldNdx(), oofem::Shell7Base::evalInitialDirectorAt(), oofem::NURBSInterpolation::evalN(), oofem::TSplineInterpolation::evalN(), oofem::BSplineInterpolation::evalN(), oofem::GeometryBasedEI::evaluateEnrFuncAt(), oofem::GeometryBasedEI::evaluateEnrFuncDerivAt(), oofem::GeometryBasedEI::evaluateEnrFuncJumps(), oofem::Shell7BaseXFEM::evaluateLevelSet(), oofem::MisesMat::give3dLSMaterialStiffnessMatrix(), oofem::BSplineInterpolation::giveBoundaryEdgeIntegrationRule(), oofem::PlaneStress2dXfem::giveCompositeExportData(), oofem::QTrPlaneStress2dXFEM::giveCompositeExportData(), oofem::TrPlaneStress2dXFEM::giveCompositeExportData(), oofem::IntElLine1PF::giveElement(), oofem::Shell7BaseXFEM::giveFailedInterfaceNumber(), oofem::StokesFlowVelocityHomogenization::giveInputRecordName(), oofem::HTSelement::giveInternalForcesVector(), oofem::PrescribedMean::giveInternalForcesVector(), oofem::IntElLine1IntPen::giveInternalForcesVector(), oofem::IntElLine2IntPen::giveInternalForcesVector(), oofem::StructuralInterfaceElement::giveInternalForcesVector(), oofem::WeakPeriodicBoundaryCondition::giveInternalForcesVector(), oofem::PhaseFieldElement::giveInternalForcesVector_d(), oofem::PhaseFieldElement::giveInternalForcesVector_u(), oofem::StructuralInterfaceElementPhF::giveInternalForcesVector_u(), oofem::CoupledFieldsElement::giveInternalForcesVectorGen(), oofem::StructuralInterfaceElementPhF::giveInternalLength(), oofem::tet21ghostsolid::giveIPValue(), oofem::StructuralElement::giveIPValue(), oofem::Shell7Base::giveL2contribution(), oofem::LevelSetPCS::giveMaterialMixtureAt(), oofem::FCMMaterial::giveNumberOfCracksForShearDirection(), oofem::FCMMaterial::giveNumberOfCracksInDirection(), oofem::PhaseFieldElement::giveRelaxationTime(), oofem::XfemStructuralElementInterface::giveSubtriangulationCompositeExportData(), oofem::FEI2dTrLinAxi::giveTransformationJacobian(), oofem::FEI2dQuadLinAxi::giveTransformationJacobian(), oofem::FEI2dQuadQuadAxi::giveTransformationJacobian(), oofem::Shell7Base::giveUnknownsAt(), oofem::Grid::Grid(), oofem::Heap::Heap(), oofem::Homogenize::herveZaoui(), oofem::UnstructuredGridField::Cell::interpolate(), oofem::IntMatBilinearCZJanssonStatus::IntMatBilinearCZJanssonStatus(), oofem::Inclusion::isMaterialModified(), oofem::NURBSInterpolation::local2global(), oofem::FEI3dTetQuad::local2global(), oofem::TSplineInterpolation::local2global(), oofem::BSplineInterpolation::local2global(), oofem::Shell7Base::nodalLeastSquareFitFromIP(), oofem::Triangle::pointIsInTriangle(), oofem::PLPrincipalStrain::propagateInterface(), oofem::PLHoopStressCirc::propagateInterface(), oofem::M1MaterialStatus::restoreContext(), oofem::Heap::setToEmpty(), oofem::FEI3dTrLin::surfaceLocal2global(), oofem::FEI3dTetQuad::surfaceLocal2global(), oofem::FEI3dTrQuad::surfaceLocal2global(), oofem::SymCompCol::times(), oofem::CompCol::times(), oofem::CompCol::timesT(), oofem::EnrichmentItem::tipIsTouchingEI(), oofem::TR21_2D_SUPG::updateStabilizationCoeffs(), oofem::Quad10_2D_SUPG::updateStabilizationCoeffs(), oofem::Shell7Base::vtkEvalInitialGlobalCoordinateAt(), and oofem::Shell7Base::vtkEvalInitialGlobalCZCoordinateAt().

#define Nt (   p,
 
)    t.at(p, q)

Definition at line 480 of file mdm.C.

Referenced by oofem::MDM::transformStressFromPDC().


This page is part of the OOFEM documentation. Copyright (c) 2011 Borek Patzak
Project e-mail: info@oofem.org
Generated at Tue Jan 2 2018 20:07:32 for OOFEM by doxygen 1.8.11 written by Dimitri van Heesch, © 1997-2011