OOFEM 3.0
Loading...
Searching...
No Matches
oofem::EngngModel Class Referenceabstract

#include <engngm.h>

Inheritance diagram for oofem::EngngModel:
Collaboration diagram for oofem::EngngModel:

Classes

struct  ArrayWithNumbering
 Helper struct to pass array and numbering scheme as a single argument. More...

Public Types

enum  EngngModel_UpdateMode { EngngModel_Unknown_Mode , EngngModel_SUMM_Mode , EngngModel_SET_Mode }
enum  EngngModelCommType { PC_default , PC_nonlocal }
enum  InitialGuess { IG_None = 0 , IG_Tangent = 1 }

Protected Attributes

int ndomains
 Number of receiver domains.
std ::vector< std ::unique_ptr< Domain > > domainList
 List of problem domains.
int numberOfSteps
 Total number of time steps.
int numberOfEquations
 Total number of equation in current time step.
int numberOfPrescribedEquations
 Total number or prescribed equations in current time step.
IntArray domainNeqs
 Number of equations per domain.
IntArray domainPrescribedNeqs
 Number of prescribed equations per domain.
bool renumberFlag
 Renumbering flag (renumbers equations after each step, necessary if Dirichlet BCs change).
bool profileOpt
 Profile optimized numbering flag (using Sloan's algorithm).
int equationNumberingCompleted
 Equation numbering completed flag.
int nMetaSteps
 Number of meta steps.
std ::vector< MetaStepmetaStepList
 List of problem metasteps.
std ::unique_ptr< TimeStepstepWhenIcApply
 Solution step when IC (initial conditions) apply.
std ::unique_ptr< TimeStepcurrentStep
 Current time step.
std ::unique_ptr< TimeSteppreviousStep
 Previous time step.
int number
 Receivers id.
std::string dataOutputFileName
 Path to output stream.
std::string coreOutputFileName
 String with core output file name.
FILE * outputStream
 Output stream.
std::string referenceFileName
 String with reference file name.
ContextOutputMode contextOutputMode
 Domain context output mode.
int contextOutputStep
ExportModuleManager exportModuleManager
 Export module manager.
InitModuleManager initModuleManager
 Initialization module manager.
MonitorManager monitorManager
 Monitor manager.
problemMode pMode
 Domain mode.
problemScale pScale
 Multiscale mode.
time_t startTime
 Solution start time.
EngngModelmaster
 Master e-model; if defined receiver is in maintained (slave) mode.
EngngModelContextcontext
 Context.
EngngModelTimer timer
 E-model timer.
int parallelFlag
 Flag indicating that the receiver runs in parallel.
enum fMode nonLinFormulation
 Type of non linear formulation (total or updated formulation).
std::unique_ptr< ErrorEstimatordefaultErrEstimator
 Error estimator. Useful for adaptivity, or simply printing errors output.
std::unique_ptr< TimeStepControllertimeStepController
 Time Step controller is responsible for collecting data from analysis, elements, and materials, and select the appropriate timestep size for the next step, or reduce the step in case of convergence problems.
int rank
 Domain rank in a group of collaborating processes (0..groupSize-1).
int numProcs
 Total number of collaborating processes.
int nonlocalExt
 Flag indicating if nonlocal extension active, which will cause data to be sent between shared elements before computing the internal forces.
char processor_name [PROCESSOR_NAME_LENGTH]
 Processor name.
MPI_Comm comm
 Communication object for this engineering model.

Load balancing attributes

enum  {
  InternalForcesExchangeTag , MassExchangeTag , LoadExchangeTag , ReactionExchangeTag ,
  RemoteElementExchangeTag
}
 Message tags. More...
std::unique_ptr< LoadBalancerlb
 Load Balancer.
std::unique_ptr< LoadBalancerMonitorlbm
bool loadBalancingFlag
 If set to true, load balancing is active.
bool force_load_rebalance_in_first_step
 Debug flag forcing load balancing after first step.
CommunicatorBuffcommBuff
 Common Communicator buffer.
ProblemCommunicatorcommunicator
 Communicator.
ProblemCommunicatornonlocCommunicator
 NonLocal Communicator. Necessary when nonlocal constitutive models are used.
std ::vector< ParallelContextparallelContextList
 List where parallel contexts are stored.
bool suppressOutput
 Flag for suppressing output to file.
std::string simulationDescription
 EngngModel (int i, EngngModel *_master=NULL)
virtual ~EngngModel ()
 Destructor.
 EngngModel (const EngngModel &)=delete
EngngModeloperator= (const EngngModel &)=delete
DomaingiveDomain (int n)
void setDomain (int i, Domain *ptr, bool iDeallocateOld=true)
int giveNumberOfDomains ()
 Returns number of domains in problem.
const std::string & giveDescription () const
const time_t & giveStartTime ()
bool giveSuppressOutput () const
virtual ErrorEstimatorgiveDomainErrorEstimator (int n)
virtual MaterialInterfacegiveMaterialInterface (int n)
void setNumberOfEquations (int id, int neq)
FILE * giveOutputStream ()
 Returns file descriptor of output file.
std::string giveOutputBaseFileName ()
std::string giveReferenceFileName ()
void letOutputBaseFileNameBe (const std ::string &src)
ContextOutputMode giveContextOutputMode () const
int giveContextOutputStep () const
void setContextOutputMode (ContextOutputMode contextMode)
void setUDContextOutputMode (int cStep)
double giveDeltaT ()
 Returns time step size from the time step controlelr.
void setDeltaT (double dT)
 Returns time step size through the time step controlelr.
void setProblemMode (problemMode pmode)
void setParallelMode (bool newParallelFlag)
problemMode giveProblemMode () const
 Returns domain mode.
void setProblemScale (problemScale pscale)
problemScale giveProblemScale () const
 Returns scale in multiscale simulation.
virtual void setRenumberFlag ()
 Sets the renumber flag to true.
virtual void resetRenumberFlag ()
 Sets the renumber flag to false.
double giveSolutionStepTime ()
void giveAnalysisTime (int &rhrs, int &rmin, int &rsec, int &uhrs, int &umin, int &usec)
void terminateAnalysis ()
virtual void solveYourself ()
virtual void restartYourself (TimeStep *tS)
virtual void solveYourselfAt (TimeStep *tStep)
virtual void terminate (TimeStep *tStep)
virtual void doStepOutput (TimeStep *tStep)
void saveStepContext (TimeStep *tStep, ContextMode mode)
virtual void updateYourself (TimeStep *tStep)
virtual void initializeYourself (TimeStep *tStep)
virtual int initializeAdaptive (int tStepNumber)
virtual int giveNumberOfDomainEquations (int di, const UnknownNumberingScheme &num)
virtual double giveUnknownComponent (ValueModeType, TimeStep *, Domain *, Dof *)
virtual FieldPtr giveField (FieldType key, TimeStep *)
virtual FieldPtr giveField (InternalStateType key, TimeStep *)
EngngModelgiveMasterEngngModel ()
 Returns the master engnmodel.
virtual double giveLoadLevel ()
 Returns the current load level.
virtual double giveEigenValue (int eigNum)
 Only relevant for eigen value analysis. Otherwise returns zero.
virtual void setActiveVector (int i)
 Only relevant for eigen value analysis. Otherwise does noting.
int updateSharedDofManagers (FloatArray &answer, const UnknownNumberingScheme &s, int ExchangeTag)
int exchangeRemoteElementData (int ExchangeTag)
virtual int giveCurrentNumberOfIterations ()
MPI_Comm giveParallelComm ()
 Returns the communication object of reciever.
int packRemoteElementData (ProcessCommunicator &processComm)
int unpackRemoteElementData (ProcessCommunicator &processComm)
int packDofManagers (ArrayWithNumbering *src, ProcessCommunicator &processComm)
int unpackDofManagers (ArrayWithNumbering *dest, ProcessCommunicator &processComm)
ProblemCommunicatorgiveProblemCommunicator (EngngModelCommType t)
void initializeCommMaps (bool forceInit=false)
virtual int instanciateYourself (DataReader &dr, InputRecord &ir, const char *outFileName, const char *desc)
void Instanciate_init ()
virtual void initializeFrom (InputRecord &ir)
int instanciateDomains (DataReader &dr)
 Instanciate problem domains by calling their instanciateYourself() service.
int instanciateMetaSteps (DataReader &dr)
 Instanciate problem meta steps by calling their instanciateYourself() service.
virtual int instanciateDefaultMetaStep (InputRecord &ir)
 Instanciate default metastep, if nmsteps is zero.
virtual void updateAttributes (MetaStep *mStep)
void initMetaStepAttributes (MetaStep *mStep)
virtual void saveContext (DataStream &stream, ContextMode mode)
virtual void restoreContext (DataStream &stream, ContextMode mode)
virtual void updateDomainLinks ()
MetaStepgiveCurrentMetaStep ()
 Returns current meta step.
virtual TimeStepgiveCurrentStep (bool force=false)
virtual void adaptTimeStep (double nIter)
virtual TimeStepgivePreviousStep (bool force=false)
virtual TimeStepgiveNextStep ()
 Returns next time step (next to current step) of receiver.
virtual void preInitializeNextStep ()
 Does a pre-initialization of the next time step (implement if necessarry).
virtual TimeStepgiveSolutionStepWhenIcApply (bool force=false)
virtual int giveNumberOfFirstStep (bool force=false)
int giveNumberOfMetaSteps ()
 Return number of meta steps.
MetaStepgiveMetaStep (int i)
 Returns the i-th meta step.
int giveNumberOfSteps (bool force=false)
virtual double giveEndOfTimeOfInterest ()
 Returns end of time interest (time corresponding to end of time integration).
int giveNumberOfTimeStepWhenIcApply ()
 Returns the time step number, when initial conditions should apply.
virtual NumericalMethodgiveNumericalMethod (MetaStep *mStep)
 Returns reference to receiver's numerical method.
ExportModuleManagergiveExportModuleManager ()
 Returns receiver's export module manager.
EngngModelTimergiveTimer ()
 Returns reference to receiver timer (EngngModelTimer).
virtual double giveInitialTime ()
 return time at the begining of analysis
virtual double giveFinalTime ()
virtual int giveNewEquationNumber (int domain, DofIDItem)
virtual int giveNewPrescribedEquationNumber (int domain, DofIDItem)
std::string giveContextFileName (int tStepNumber, int stepVersion) const
std::string giveDomainFileName (int domainNum, int domainSerNum) const
virtual void updateComponent (TimeStep *tStep, NumericalCmpn cmpn, Domain *d)
virtual void initForNewIteration (Domain *d, TimeStep *tStep, int iterationNumber, const FloatArray &solution)
virtual void updateSolution (FloatArray &solutionVector, TimeStep *tStep, Domain *d)
virtual void updateInternalRHS (FloatArray &answer, TimeStep *tStep, Domain *d, FloatArray *eNorm)
virtual void updateMatrix (SparseMtrx &mat, TimeStep *tStep, Domain *d)
virtual void initStepIncrements ()
virtual int forceEquationNumbering (int i)
virtual int forceEquationNumbering ()
virtual int requiresUnknownsDictionaryUpdate ()
virtual bool requiresEquationRenumbering (TimeStep *tStep)
virtual void updateDofUnknownsDictionary (DofManager *, TimeStep *)
virtual int giveUnknownDictHashIndx (ValueModeType mode, TimeStep *tStep)
virtual bool newDofHandling ()
virtual ParallelContextgiveParallelContext (int n)
virtual void initParallelContexts ()
virtual void assemble (SparseMtrx &answer, TimeStep *tStep, const MatrixAssembler &ma, const UnknownNumberingScheme &s, Domain *domain)
virtual void assemble (SparseMtrx &answer, TimeStep *tStep, const MatrixAssembler &ma, const UnknownNumberingScheme &r_s, const UnknownNumberingScheme &c_s, Domain *domain)
void assembleVector (FloatArray &answer, TimeStep *tStep, const VectorAssembler &va, ValueModeType mode, const UnknownNumberingScheme &s, Domain *domain, FloatArray *eNorms=NULL)
void assembleVectorFromDofManagers (FloatArray &answer, TimeStep *tStep, const VectorAssembler &va, ValueModeType mode, const UnknownNumberingScheme &s, Domain *domain, FloatArray *eNorms=NULL)
void assembleVectorFromElements (FloatArray &answer, TimeStep *tStep, const VectorAssembler &va, ValueModeType mode, const UnknownNumberingScheme &s, Domain *domain, FloatArray *eNorms=NULL)
void assembleVectorFromBC (FloatArray &answer, TimeStep *tStep, const VectorAssembler &va, ValueModeType mode, const UnknownNumberingScheme &s, Domain *domain, FloatArray *eNorms=NULL)
void assembleExtrapolatedForces (FloatArray &answer, TimeStep *tStep, CharType type, Domain *domain)
void assemblePrescribedExtrapolatedForces (FloatArray &answer, TimeStep *tStep, CharType type, Domain *domain)
virtual int checkConsistency ()
virtual int checkProblemConsistency ()
virtual void init ()
virtual void postInitialize ()
virtual void printOutputAt (FILE *file, TimeStep *tStep)
virtual void printOutputAt (FILE *file, TimeStep *tStep, const IntArray &nodeSets, const IntArray &elementSets)
void outputNodes (FILE *file, Domain &domain, TimeStep *tStep, int setNum)
void outputElements (FILE *file, Domain &domain, TimeStep *tStep, int setNum)
void printYourself ()
 Prints state of receiver. Useful for debugging.
virtual void printDofOutputAt (FILE *stream, Dof *iDof, TimeStep *tStep)
virtual const char * giveClassName () const =0
 Returns class name of the receiver.
virtual int useNonlocalStiffnessOption ()
 Returns nonzero if nonlocal stiffness option activated.
bool isParallel () const
 Returns true if receiver in parallel mode.
int giveRank () const
 Returns domain rank in a group of collaborating processes (0..groupSize-1).
int giveNumberOfProcesses () const
 Returns the number of collaborating processes.
virtual fMode giveFormulation ()
EngngModelContextgiveContext ()
 Context requesting service.
virtual int giveNumberOfSlaveProblems ()
 Returns number of slave problems.
virtual EngngModelgiveSlaveProblem (int i)
 Returns i-th slave problem.
virtual bool giveEquationScalingFlag ()
 Returns the Equation scaling flag, which is used to indicate that governing equation(s) are scaled, or non-dimensionalized.
virtual double giveVariableScale (VarScaleType varId)
 Returns the scale factor for given variable type.
virtual int estimateMaxPackSize (IntArray &commMap, DataStream &buff, int packUnpackType)
virtual void balanceLoad (TimeStep *tStep)
virtual LoadBalancergiveLoadBalancer ()
virtual LoadBalancerMonitorgiveLoadBalancerMonitor ()
void initParallel ()
 Request domain rank and problem size.
EngngModelgiveEngngModel ()
 Returns reference to itself -> required by communicator.h.
virtual bool isElementActivated (int elemNum)
virtual bool isElementActivated (Element *e)
TimeStepControllergiveTimeStepController ()
 Returns the time step controller.
virtual void drawYourself (oofegGraphicContext &gc)
virtual void drawElements (oofegGraphicContext &gc)
virtual void drawNodes (oofegGraphicContext &gc)
virtual void showSparseMtrxStructure (int type, oofegGraphicContext &gc, TimeStep *tStep)
std::string errorInfo (const char *func) const
 Returns string for prepending output (used by error reporting macros).
virtual void packMigratingData (TimeStep *tStep)
virtual void unpackMigratingData (TimeStep *tStep)

Detailed Description

Abstract base class representing the "problem" under consideration. The engineering model describes the problem and type of analysis to be done. It "knows" the type and form of governing equation, knows how to assemble this problem from local element contributions and uses suitable instance of numerical method class to solve problem. It possesses and manages one or more problem domains. Concept of time steps is introduced. For problems discretized in time the introduction of time step is natural. In other cases, time steps can represent for example load increments or different load cases.

The solution steps are grouped together into so called meta steps. The meta step can be thought as an sequence of solution steps, with same set of attributes used to drive behavior of engng model. For each metastep, the engng model typically updates its control attributes according to metastep engng attributes (see initMetaStepAttributes and updateAttributes services) and creates the solution steps accordingly. This allows to switch to different time increment, different solution control, etc. If no metastep is specified, the engng model creates default one for all required solution steps. There are two services, where attributes are updated, the first one, used for those attributes, which do not vary during solution of problem are set in initializeFrom service. The second service is updateAttributes, where the attributes allowed to change (with metastep validity) are updated. If no metastep is introduced, default one is created (with attributes set to engng model init record). Then there is no difference, whether attributes are read in initializeFrom or updateAttributes, but preferred scheme is to read all attributes in initializeFrom and left updateAttributes service empty.

The basic EngngModel tasks are following

  • Assembling governing equations by summing contributions from problem domains (typically from nodes and elements),
  • Solving the problem described by governing equation(s) using suitable instance of numerical method. This requires interfacing numericalMethod characteristic elements with components in governing equation EngngModel must map each component of governing equation(s) (which has physical meaning) to corresponding numerical component of Numerical method. This mapping between physical components to independent numerical components (understood by numerical method) is important, because it allows numerical method to be used by many EngngModel with different meaning of particular components.
  • Returning unknown values (according to requested type and mode). Used by Dofs to access their corresponding unknowns.
  • Terminating time step by updating nodal and element values (including integration points update).
  • Updating dofs unknowns dictionaries if model supports changes of static system (see Dof class documentation for detailed explanation). In general if static system changes are not supported, when dof are requested for unknowns, they use their associate equation number to ask EngngModel for this unknown. Unknowns are therefore stored in EngngModel and are requested by dofs. On the other hand, when static system changes are supported, the equation numbers of dofs can vary during solution. Therefore, so called unknowns dictionary at dof level are introduced. All unknowns are stored on dof level and dofs will use in such case their own dictionaries instead of requesting EngngModel. The EngngModel is fully responsible to update this dictionary for each dof with all necessary unknowns (see updateDofUnknownsDictionary function).

Definition at line 191 of file engngm.h.

Member Enumeration Documentation

◆ anonymous enum

anonymous enum
protected

Message tags.

Enumerator
InternalForcesExchangeTag 
MassExchangeTag 
LoadExchangeTag 
ReactionExchangeTag 
RemoteElementExchangeTag 

Definition at line 321 of file engngm.h.

◆ EngngModel_UpdateMode

Enumerator
EngngModel_Unknown_Mode 
EngngModel_SUMM_Mode 
EngngModel_SET_Mode 

Definition at line 194 of file engngm.h.

◆ EngngModelCommType

Enumerator
PC_default 
PC_nonlocal 

Definition at line 195 of file engngm.h.

◆ InitialGuess

Means to choose methods for finding a good initial guess. This is ad-hoc methods, often problem-specific for obtaining a point from which Newton iterations work. Only nonlinear analysis needs to worry about this.

Enumerator
IG_None 

No special treatment for new iterations. Probably means ending up using \( {}^{n+1}x = {}^{n}x \) for all free dofs.

IG_Tangent 

Solves an approximated tangent problem from the last iteration. Useful for changing Dirichlet boundary conditions.

Definition at line 207 of file engngm.h.

Constructor & Destructor Documentation

◆ EngngModel() [1/2]

oofem::EngngModel::EngngModel ( int i,
EngngModel * _master = NULL )

Constructor. Creates Engng model with number i.

Definition at line 99 of file engngm.C.

References oofem::_processor, oofem::COM_NoContext, comm, commBuff, communicator, context, contextOutputMode, contextOutputStep, domainNeqs, domainPrescribedNeqs, EngngModel(), equationNumberingCompleted, exportModuleManager, force_load_rebalance_in_first_step, initModuleManager, lb, lbm, loadBalancingFlag, oofem::macroScale, master, monitorManager, ndomains, nMetaSteps, nonLinFormulation, nonlocalExt, nonlocCommunicator, number, numberOfEquations, numberOfPrescribedEquations, numberOfSteps, numProcs, outputStream, parallelFlag, pMode, profileOpt, pScale, rank, referenceFileName, renumberFlag, suppressOutput, timeStepController, and oofem::UNKNOWN.

Referenced by oofem::AdditiveManufacturingProblem::add_element_if_not_exists2(), oofem::AdditiveManufacturingProblem::add_node_if_not_exists2(), oofem::AdditiveManufacturingProblem::add_sm_element_if_not_exists2(), oofem::AdditiveManufacturingProblem::add_sm_node_if_not_exists2(), oofem::AdditiveManufacturingProblem::AdditiveManufacturingProblem(), oofem::DGProblem::DGProblem(), oofem::DummyEngngModel::DummyEngngModel(), oofem::EigenValueDynamic::EigenValueDynamic(), EngngModel(), EngngModel(), oofem::FluidMaterialEvaluator::FluidMaterialEvaluator(), oofem::FluidModel::FluidModel(), oofem::ProblemSequence::giveActiveModel(), oofem::AdditiveManufacturingProblem::giveDeltaT(), oofem::StaggeredProblem::giveDeltaT(), giveEngngModel(), giveMasterEngngModel(), giveSlaveProblem(), oofem::ProblemSequence::giveSlaveProblem(), oofem::MPMProblem::MPMProblem(), operator=(), oofem::PFEM::PFEM(), oofem::AdditiveManufacturingProblem::printYourself(), oofem::StaggeredProblem::printYourself(), oofem::ProblemSequence::ProblemSequence(), oofem::AdditiveManufacturingProblem::solveYourself(), oofem::StaggeredProblem::solveYourself(), oofem::StaggeredProblem::StaggeredProblem(), oofem::StationaryMPMSProblem::StationaryMPMSProblem(), oofem::StationaryTransportProblem::StationaryTransportProblem(), oofem::StructuralEngngModel::StructuralEngngModel(), oofem::StructuralMaterialEvaluator::StructuralMaterialEvaluator(), oofem::TestProblem::TestProblem(), and oofem::TransientTransportProblem::TransientTransportProblem().

◆ ~EngngModel()

oofem::EngngModel::~EngngModel ( )
virtual

Destructor.

Definition at line 154 of file engngm.C.

References commBuff, communicator, context, master, nonlocCommunicator, and outputStream.

◆ EngngModel() [2/2]

oofem::EngngModel::EngngModel ( const EngngModel & )
delete

References EngngModel().

Member Function Documentation

◆ adaptTimeStep()

virtual void oofem::EngngModel::adaptTimeStep ( double nIter)
inlinevirtual

Adapt time step according to the number of iterations in the previous step

Reimplemented in oofem::StaticStructural.

Definition at line 729 of file engngm.h.

Referenced by solveYourself().

◆ assemble() [1/2]

void oofem::EngngModel::assemble ( SparseMtrx & answer,
TimeStep * tStep,
const MatrixAssembler & ma,
const UnknownNumberingScheme & r_s,
const UnknownNumberingScheme & c_s,
Domain * domain )
virtual

Assembles characteristic matrix of required type into given sparse matrix.

Parameters
answerassembled matrix
tStepTime step, when answer is assembled.
r_sDetermines the equation numbering scheme for the rows.
c_sDetermines the equation numbering scheme for the columns.
typeCharacteristic components of type type are requested from elements and assembled.
domainSource domain.
Todo
This rotation matrix is not flexible enough.. it can only work with full size matrices and doesn't allow for flexibility in the matrixassembler.

Definition at line 1040 of file engngm.C.

References oofem::SparseMtrx::assemble(), oofem::SparseMtrx::assembleBegin(), oofem::SparseMtrx::assembleEnd(), oofem::MatrixAssembler::assembleFromActiveBC(), oofem::Element_remote, oofem::Domain::giveBcs(), oofem::Domain::giveElement(), oofem::Domain::giveNumberOfElements(), oofem::Element::giveParallelMode(), oofem::Element::giveRotationMatrix(), oofem::Element::isActivated(), oofem::FloatMatrix::isNotEmpty(), oofem::MatrixAssembler::locationFromElement(), oofem::MatrixAssembler::matrixFromElement(), OOFEM_ERROR, oofem::FloatMatrix::rotatedWith(), and timer.

◆ assemble() [2/2]

void oofem::EngngModel::assemble ( SparseMtrx & answer,
TimeStep * tStep,
const MatrixAssembler & ma,
const UnknownNumberingScheme & s,
Domain * domain )
virtual

Assembles characteristic matrix of required type into given sparse matrix.

Parameters
answerAssembled matrix.
tStepTime step, when answer is assembled.
sDetermines the equation numbering scheme.
typeCharacteristic components of type type are requested from elements and assembled.
domainSource domain.
Todo
This rotation matrix is not flexible enough.. it can only work with full size matrices and doesn't allow for flexibility in the matrixassembler.
Note
: Some active bcs still make changes even when they are not applied We should probably reconsider this approach, so that they e.g. just prescribe their lagrange mult. instead.

Reimplemented in oofem::NonLinearDynamic, and oofem::NonLinearStatic.

Definition at line 889 of file engngm.C.

References oofem::SparseMtrx::assemble(), oofem::SparseMtrx::assembleBegin(), oofem::SparseMtrx::assembleEnd(), oofem::MatrixAssembler::assembleFromActiveBC(), oofem::FloatMatrix::clear(), oofem::Element_remote, oofem::Domain::giveBcs(), oofem::Set::giveBoundaryList(), oofem::Set::giveEdgeList(), oofem::Domain::giveElement(), oofem::Set::giveElementList(), oofem::Domain::giveNumberOfElements(), oofem::Domain::giveSet(), oofem::FloatMatrix::isNotEmpty(), oofem::MatrixAssembler::locationFromElement(), oofem::MatrixAssembler::locationFromElementNodes(), oofem::MatrixAssembler::matrixFromEdgeLoad(), oofem::MatrixAssembler::matrixFromElement(), oofem::MatrixAssembler::matrixFromLoad(), oofem::MatrixAssembler::matrixFromSurfaceLoad(), OOFEM_ERROR, oofem::FloatMatrix::rotatedWith(), and timer.

Referenced by oofem::PrescribedDispSlipBCDirichletRC::computeTangent(), oofem::PrescribedGenStrainShell7::computeTangent(), oofem::PrescribedGradient::computeTangent(), oofem::PrescribedGradientBCNeumann::computeTangent(), oofem::PrescribedGradientBCPeriodic::computeTangent(), oofem::PrescribedGradientBCWeak::computeTangent(), oofem::TransportGradientDirichlet::computeTangent(), oofem::TransportGradientNeumann::computeTangent(), oofem::TransportGradientPeriodic::computeTangent(), oofem::MixedGradientPressureDirichlet::computeTangents(), oofem::MixedGradientPressureNeumann::computeTangents(), oofem::MixedGradientPressureWeakPeriodic::computeTangents(), and oofem::MicroMaterial::giveMacroStiffnessMatrix().

◆ assembleExtrapolatedForces()

void oofem::EngngModel::assembleExtrapolatedForces ( FloatArray & answer,
TimeStep * tStep,
CharType type,
Domain * domain )

Assembles the extrapolated internal forces vector, useful for obtaining a good initial guess in nonlinear analysis with Dirichlet boundary conditions.

Parameters
answerAssembled vector.
tStepTime step, when answer is assembled.
typeDetermines the type of matrix to use, typically the tangent matrix or possibly the elastic tangent.
domainDomain to assemble from.
Returns
Sum of element norm (squared) of assembled vector.
Todo
This is not perfect. It is probably no good for viscoelastic materials, and possibly other scenarios that are rate dependent (tangent will be computed for the previous step, with whatever deltaT it had)
Note
Temporary work-around for active b.c. used in multiscale (it can't support VM_Incremental easily).
Todo
Deal with element deactivation and reactivation properly.

Definition at line 1536 of file engngm.C.

References oofem::FloatArray::assemble(), oofem::FloatArray::beProductOf(), oofem::Element::computeVectorOf(), oofem::Element_remote, oofem::Element::giveCharacteristicMatrix(), oofem::Domain::giveElement(), oofem::Element::giveLocationArray(), oofem::Domain::giveNumber(), giveNumberOfDomainEquations(), oofem::Domain::giveNumberOfElements(), oofem::Element::giveParallelMode(), oofem::TimeStep::givePreviousStep(), oofem::Element::giveRotationMatrix(), oofem::Element::isActivated(), oofem::FloatMatrix::isNotEmpty(), oofem::TimeStep::isTheFirstStep(), oofem::FloatArray::resize(), oofem::FloatArray::rotatedWith(), oofem::FloatArray::subtract(), timer, and oofem::FloatArray::zero().

Referenced by oofem::StaticStructural::solveYourselfAt().

◆ assemblePrescribedExtrapolatedForces()

void oofem::EngngModel::assemblePrescribedExtrapolatedForces ( FloatArray & answer,
TimeStep * tStep,
CharType type,
Domain * domain )

◆ assembleVector()

void oofem::EngngModel::assembleVector ( FloatArray & answer,
TimeStep * tStep,
const VectorAssembler & va,
ValueModeType mode,
const UnknownNumberingScheme & s,
Domain * domain,
FloatArray * eNorms = NULL )

Assembles characteristic vector of required type from dofManagers, element, and active boundary conditions, into given vector. This routine is simple a convenient call to all three subroutines, since this is most likely what any engineering model will want to do. The return value is used to normalize the residual when checking for convergence in nonlinear problems. For parallel problems, the returned norm is also summed over all processes.

Parameters
answerAssembled vector.
modeMode of unknown (total, incremental, rate of change).
tStepTime step, when answer is assembled.
vaDetermines what vector is assembled.
sDetermines the equation numbering scheme.
domainDomain to assemble from.
eNormsIf non-NULL, squared norms of each internal force will be added to this, split up into dof IDs.
Returns
Sum of element/node norm (squared) of assembled vector.

Definition at line 1106 of file engngm.C.

References assembleVectorFromBC(), assembleVectorFromDofManagers(), assembleVectorFromElements(), comm, oofem::Domain::giveMaxDofID(), oofem::Domain::giveNumber(), giveParallelContext(), isParallel(), oofem::FloatArray::resize(), and oofem::FloatArray::zero().

Referenced by oofem::NonLinearStatic::assembleIncrementalReferenceLoadVectors(), oofem::DIIDynamic::assembleLoadVector(), oofem::StaticStructural::computeExternalLoadReactionContribution(), oofem::StructuralEngngModel::computeExternalLoadReactionContribution(), oofem::PrescribedGenStrainShell7::computeField(), oofem::PrescribedGradient::computeField(), oofem::PrescribedGradientBCPeriodic::computeField(), oofem::TransportGradientDirichlet::computeField(), oofem::TransportGradientPeriodic::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::NlDEIDynamic::computeLoadVector(), oofem::StructuralEngngModel::computeReaction(), oofem::PrescribedDispSlipBCDirichletRC::computeReinfStress(), oofem::PrescribedDispSlipBCDirichletRC::computeStress(), oofem::PrescribedDispSlipBCDirichletRC::computeTransferStress(), oofem::TransientTransportProblem::printOutputAt(), oofem::NonLinearDynamic::proceedStep(), oofem::DEIDynamic::solveYourselfAt(), oofem::DGProblem::solveYourselfAt(), oofem::FreeWarping::solveYourselfAt(), oofem::IncrementalLinearStatic::solveYourselfAt(), oofem::LinearStability::solveYourselfAt(), oofem::LinearStatic::solveYourselfAt(), oofem::MPMProblem::solveYourselfAt(), oofem::Pdelta::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::StaticStructural::solveYourselfAt(), oofem::StationaryTransportProblem::solveYourselfAt(), oofem::StokesFlow::solveYourselfAt(), oofem::SUPG::solveYourselfAt(), oofem::TransientTransportProblem::solveYourselfAt(), oofem::MPMProblem::updateComponent(), oofem::StaticStructural::updateComponent(), oofem::StationaryTransportProblem::updateComponent(), oofem::StokesFlow::updateComponent(), oofem::SUPG::updateComponent(), oofem::TransientTransportProblem::updateComponent(), oofem::MPMProblem::updateInternalRHS(), oofem::StaticStructural::updateInternalRHS(), oofem::StationaryTransportProblem::updateInternalRHS(), oofem::StokesFlow::updateInternalRHS(), oofem::StructuralEngngModel::updateInternalRHS(), oofem::SUPG::updateInternalRHS(), and oofem::TransientTransportProblem::updateInternalRHS().

◆ assembleVectorFromBC()

void oofem::EngngModel::assembleVectorFromBC ( FloatArray & answer,
TimeStep * tStep,
const VectorAssembler & va,
ValueModeType mode,
const UnknownNumberingScheme & s,
Domain * domain,
FloatArray * eNorms = NULL )

Assembles characteristic vector of required type from boundary conditions.

Parameters
answerAssembled vector.
tStepTime step, when answer is assembled.
modeMode of unknown (total, incremental, rate of change).
vaDetermines what vector is assembled.
sDetermines the equation numbering scheme.
domainDomain to assemble from.
eNormsNorms for each dofid (optional).

Definition at line 1191 of file engngm.C.

References oofem::FloatArray::assemble(), oofem::VectorAssembler::assembleFromActiveBC(), oofem::FloatArray::assembleSquared(), oofem::IntArray::at(), oofem::FloatArray::clear(), oofem::Element::computeDofTransformationMatrix(), oofem::DofManager::computeM2LTransformation(), oofem::EdgeLoadBGT, oofem::Domain::giveBc(), oofem::GeneralBoundaryCondition::giveBCGeoType(), oofem::Element::giveBoundaryEdgeNodes(), oofem::Set::giveBoundaryList(), oofem::Element::giveBoundarySurfaceNodes(), oofem::GeneralBoundaryCondition::giveDofIDs(), oofem::Domain::giveDofManager(), oofem::Set::giveEdgeList(), oofem::Domain::giveElement(), oofem::Set::giveElementList(), oofem::DofManager::giveLocationArray(), oofem::Set::giveNodeList(), oofem::Domain::giveNumberOfBoundaryConditions(), oofem::Element::giveRotationMatrix(), oofem::Domain::giveSet(), oofem::GeneralBoundaryCondition::giveSetNumber(), oofem::IntArray::giveSize(), oofem::Element::isActivated(), oofem::GeneralBoundaryCondition::isImposed(), oofem::FloatArray::isNotEmpty(), oofem::VectorAssembler::locationFromElement(), oofem::VectorAssembler::locationFromElementNodes(), oofem::FloatArray::rotatedWith(), oofem::SurfaceLoadBGT, timer, oofem::VectorAssembler::vectorFromEdgeLoad(), oofem::VectorAssembler::vectorFromLoad(), oofem::VectorAssembler::vectorFromNodeLoad(), and oofem::VectorAssembler::vectorFromSurfaceLoad().

Referenced by assembleVector().

◆ assembleVectorFromDofManagers()

void oofem::EngngModel::assembleVectorFromDofManagers ( FloatArray & answer,
TimeStep * tStep,
const VectorAssembler & va,
ValueModeType mode,
const UnknownNumberingScheme & s,
Domain * domain,
FloatArray * eNorms = NULL )

Assembles characteristic vector of required type from dofManagers into given vector.

Parameters
answerAssembled vector.
modeMode of unknown (total, incremental, rate of change).
tStepTime step, when answer is assembled.
vaDetermines what vector is assembled.
sDetermines the equation numbering scheme.
domainDomain to assemble from.
eNormsNorms for each dofid (optional).
Returns
Sum of element norm (squared) of assembled vector.
Todo
This should be removed when loads are given through sets.

Definition at line 1136 of file engngm.C.

References oofem::FloatArray::assemble(), oofem::FloatArray::assembleSquared(), oofem::FloatArray::clear(), oofem::DofManager::computeM2LTransformation(), oofem::DofManager_shared, oofem::DofManager::giveCompleteLocationArray(), oofem::DofManager::giveCompleteMasterDofIDArray(), oofem::GeneralBoundaryCondition::giveDofIDs(), oofem::Domain::giveDofManager(), oofem::Domain::giveLoad(), oofem::DofManager::giveLoadArray(), oofem::DofManager::giveLocationArray(), oofem::Domain::giveNumberOfDofManagers(), oofem::DofManager::giveParallelMode(), oofem::DofManager::givePartitionsConnectivitySize(), oofem::IntArray::giveSize(), oofem::FloatArray::isNotEmpty(), oofem::FloatArray::rotatedWith(), timer, oofem::FloatArray::times(), and oofem::VectorAssembler::vectorFromNodeLoad().

Referenced by assembleVector(), oofem::NLTransientTransportProblem::solveYourselfAt(), and oofem::NonStationaryTransportProblem::solveYourselfAt().

◆ assembleVectorFromElements()

void oofem::EngngModel::assembleVectorFromElements ( FloatArray & answer,
TimeStep * tStep,
const VectorAssembler & va,
ValueModeType mode,
const UnknownNumberingScheme & s,
Domain * domain,
FloatArray * eNorms = NULL )

Assembles characteristic vector of required type from elements into given vector.

Parameters
answerAssembled vector.
tStepTime step, when answer is assembled.
modeMode of unknown (total, incremental, rate of change).
vaDetermines what vector is assembled.
sDetermines the equation numbering scheme.
domainDomain to assemble from.
eNormsNorms for each dofid (optional).
Returns
Sum of element norm (squared) of assembled vector.
Todo
Checking the chartype is not since there could be some other chartype in the future. We need to try and deal with chartype in a better way. For now, this is the best we can do.
Todo
Consider using private answer variables and sum them up at the end, but it just might be slower then a shared variable.

Definition at line 1351 of file engngm.C.

References oofem::FloatArray::assemble(), oofem::FloatArray::assembleSquared(), oofem::IntArray::at(), oofem::FloatArray::clear(), oofem::Element::computeDofTransformationMatrix(), oofem::Element_remote, exchangeRemoteElementData(), oofem::Element::giveBodyLoadList(), oofem::Element::giveBoundaryEdgeNodes(), oofem::Element::giveBoundaryLoadList(), oofem::Element::giveBoundarySurfaceNodes(), oofem::Domain::giveElement(), oofem::Domain::giveLoad(), oofem::Domain::giveNumberOfElements(), oofem::Element::giveParallelMode(), oofem::Element::giveRotationMatrix(), oofem::IntArray::giveSize(), oofem::Element::isActivated(), oofem::IntArray::isEmpty(), oofem::FloatArray::isNotEmpty(), isParallel(), oofem::VectorAssembler::locationFromElement(), oofem::VectorAssembler::locationFromElementNodes(), OOFEM_ERROR, RemoteElementExchangeTag, oofem::FloatArray::rotatedWith(), timer, oofem::VectorAssembler::vectorFromEdgeLoad(), oofem::VectorAssembler::vectorFromElement(), oofem::VectorAssembler::vectorFromLoad(), and oofem::VectorAssembler::vectorFromSurfaceLoad().

Referenced by assembleVector(), oofem::CBS::solveYourselfAt(), oofem::NLTransientTransportProblem::solveYourselfAt(), oofem::NonStationaryTransportProblem::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), and oofem::StaticStructural::solveYourselfAt().

◆ balanceLoad()

void oofem::EngngModel::balanceLoad ( TimeStep * tStep)
virtual

Recovers the load balance between processors, if needed. Uses load balancer monitor and load balancer instances to decide if rebalancing is needed (monitor) and to repartition the domain (load balancer). Method is responsible for packing all relevant data (the use of dof dictionaries is assumed to store e-model dof related staff, which can later help in renumbering after rebalancing) and to send/receive all data. Then the local update and renumbering is necessary to get consistent data structure.

Definition at line 2238 of file engngm.C.

References oofem::DofManager_local, oofem::DofManager_shared, force_load_rebalance_in_first_step, forceEquationNumbering(), giveDomain(), giveExportModuleManager(), giveLoadBalancer(), giveLoadBalancerMonitor(), giveRank(), oofem::TimeStep::isNotTheLastStep(), oofem::TimeStep::isTheFirstStep(), lb, lbm, OOFEM_LOG_INFO, OOFEM_WARNING, packMigratingData(), timer, and unpackMigratingData().

Referenced by oofem::AdditiveManufacturingProblem::solveYourself(), solveYourself(), oofem::StaggeredProblem::solveYourself(), and oofem::AdaptiveNonLinearStatic::solveYourselfAt().

◆ checkConsistency()

virtual int oofem::EngngModel::checkConsistency ( )
inlinevirtual

Allows programmer to test some receiver's internal data, before computation begins.

Returns
Nonzero if receiver check is o.k.

Reimplemented in oofem::CBS, oofem::DGProblem, oofem::FluidMaterialEvaluator, oofem::MPMProblem, oofem::NonStationaryTransportProblem, oofem::PFEM, oofem::StationaryTransportProblem, oofem::StokesFlow, oofem::StructuralEngngModel, oofem::StructuralMaterialEvaluator, oofem::SUPG, and oofem::TransientTransportProblem.

Definition at line 1091 of file engngm.h.

Referenced by checkProblemConsistency().

◆ checkProblemConsistency()

int oofem::EngngModel::checkProblemConsistency ( )
virtual

Allows programmer to test problem its internal data, before computation begins.

Returns
Nonzero if receiver check is o.k.

Reimplemented in oofem::AdditiveManufacturingProblem, oofem::ProblemSequence, and oofem::StaggeredProblem.

Definition at line 2047 of file engngm.C.

References checkConsistency(), domainList, OOFEM_LOG_DEBUG, and VERBOSE_PRINTS.

◆ doStepOutput()

void oofem::EngngModel::doStepOutput ( TimeStep * tStep)
virtual

Prints the ouput of the solution step (using virtual this->printOutputAtservice) to the stream detemined using this->giveOutputStream() method and calls exportModuleManager to do output.

Reimplemented in oofem::AdditiveManufacturingProblem, oofem::EigenValueDynamic, oofem::FluidMaterialEvaluator, oofem::LinearStability, oofem::StaggeredProblem, oofem::StokesFlow, and oofem::StructuralMaterialEvaluator.

Definition at line 756 of file engngm.C.

References exportModuleManager, giveOutputStream(), printOutputAt(), and suppressOutput.

Referenced by terminate(), and oofem::NonLinearStatic::terminate().

◆ drawElements()

void oofem::EngngModel::drawElements ( oofegGraphicContext & gc)
virtual

◆ drawNodes()

void oofem::EngngModel::drawNodes ( oofegGraphicContext & gc)
virtual

◆ drawYourself()

◆ errorInfo()

std::string oofem::EngngModel::errorInfo ( const char * func) const

Returns string for prepending output (used by error reporting macros).

Definition at line 1926 of file engngm.C.

References giveClassName(), isParallel(), and rank.

◆ estimateMaxPackSize()

virtual int oofem::EngngModel::estimateMaxPackSize ( IntArray & commMap,
DataStream & buff,
int packUnpackType )
inlinevirtual

Determines the space necessary for send/receive buffer. It uses related communication map pattern to determine the maximum size needed.

Parameters
commMapCommunication map used to send/receive messages.
buffCommunication buffer.
packUnpackTypeDetermines the type of packed quantity, used by receiver to estimate the size of pack/unpack buffer accordingly.
Returns
Upper bound of space needed.

Reimplemented in oofem::FreeWarping, oofem::LinearStatic, oofem::NlDEIDynamic, oofem::NonLinearDynamic, oofem::NonLinearStatic, and oofem::StaticStructural.

Definition at line 1195 of file engngm.h.

◆ exchangeRemoteElementData()

int oofem::EngngModel::exchangeRemoteElementData ( int ExchangeTag)

Exchanges necessary remote element data with remote partitions. The receiver's nonlocalExt flag must be set. Uses receiver nonlocCommunicator to perform the task using packRemoteElementData and unpackRemoteElementData receiver's services.

Parameters
ExchangeTagExchange tag used by communicator.
Returns
Nonzero if successful.

Definition at line 2200 of file engngm.C.

References giveRank(), isParallel(), nonlocalExt, nonlocCommunicator, OOFEM_ERROR, and VERBOSEPARALLEL_PRINT.

Referenced by oofem::AdaptiveNonLinearStatic::adaptiveRemap(), and assembleVectorFromElements().

◆ forceEquationNumbering() [1/2]

int oofem::EngngModel::forceEquationNumbering ( )
virtual

Forces equation renumbering on all domains associated to engng model. All equation numbers in all domains for all dofManagers are invalidated, and new equation numbers are generated starting from 1 on each domain. It will update numberOfEquations variable accordingly. Should be used at startup to force equation numbering and therefore sets numberOfEquations. Must be used if model supports changes of static system to assign new valid equation numbers to dofManagers.

Reimplemented in oofem::AdditiveManufacturingProblem, oofem::DGProblem, oofem::FluidModel, oofem::MPMProblem, oofem::StaggeredProblem, oofem::StaticStructural, and oofem::TransientTransportProblem.

Definition at line 534 of file engngm.C.

References domainNeqs, domainPrescribedNeqs, equationNumberingCompleted, forceEquationNumbering(), giveNumberOfDomains(), numberOfEquations, numberOfPrescribedEquations, OOFEM_LOG_DEBUG, and parallelContextList.

Referenced by oofem::StaticStructural::forceEquationNumbering(), oofem::StationaryMPMSProblem::solveYourselfAt(), and oofem::TestProblem::solveYourselfAt().

◆ forceEquationNumbering() [2/2]

int oofem::EngngModel::forceEquationNumbering ( int i)
virtual

Forces equation renumbering on given domain. All equation numbers in all dofManagers are invalidated, and new equation numbers are generated starting from domainNeqs entry corresponding to given domain. It will update numberOfEquations variable accordingly. Should be used at startup to force equation numbering and therefore sets numberOfEquations. Must be used if model supports changes of static system to assign new valid equation numbers to dofManagers.

Reimplemented in oofem::FluidModel, oofem::PFEM, and oofem::StokesFlow.

Definition at line 469 of file engngm.C.

References oofem::SloanGraph::askNewOptimalNumbering(), domainNeqs, domainPrescribedNeqs, oofem::Domain::giveBcs(), giveCurrentStep(), oofem::Domain::giveDofManagers(), giveDomain(), oofem::Domain::giveElements(), oofem::SloanGraph::giveOptimalProfileSize(), oofem::SloanGraph::initialize(), OOFEM_LOG_DEBUG, OOFEM_LOG_INFO, profileOpt, timer, and oofem::SloanGraph::tryParameters().

Referenced by oofem::AdaptiveNonLinearStatic::adaptiveRemap(), balanceLoad(), forceEquationNumbering(), giveNumberOfDomainEquations(), oofem::XfemSolverInterface::propagateXfemInterfaces(), solveYourself(), and oofem::IncrementalLinearStatic::solveYourselfAt().

◆ giveAnalysisTime()

void oofem::EngngModel::giveAnalysisTime ( int & rhrs,
int & rmin,
int & rsec,
int & uhrs,
int & umin,
int & usec )

Returns the real and user time for the analysis.

Definition at line 2011 of file engngm.C.

References timer.

Referenced by terminateAnalysis().

◆ giveClassName()

◆ giveContext()

◆ giveContextFileName()

std::string oofem::EngngModel::giveContextFileName ( int tStepNumber,
int stepVersion ) const

Returns the filename for the context file for the given step and version

Parameters
tStepNumberSolution step number to store/restore.
stepVersionVersion of step.

Definition at line 1907 of file engngm.C.

References coreOutputFileName.

Referenced by oofem::HuertaErrorEstimator::estimateError(), oofem::AdaptiveNonLinearStatic::initializeAdaptive(), and saveStepContext().

◆ giveContextOutputMode()

ContextOutputMode oofem::EngngModel::giveContextOutputMode ( ) const
inline

Returns domain context output mode.

Definition at line 402 of file engngm.h.

References contextOutputMode.

Referenced by saveStepContext().

◆ giveContextOutputStep()

int oofem::EngngModel::giveContextOutputStep ( ) const
inline

Returns domain context output step.

Definition at line 406 of file engngm.h.

References contextOutputStep.

◆ giveCurrentMetaStep()

MetaStep * oofem::EngngModel::giveCurrentMetaStep ( )

◆ giveCurrentNumberOfIterations()

virtual int oofem::EngngModel::giveCurrentNumberOfIterations ( )
inlinevirtual

Returns number of iterations that was required to reach equilibrium - used for adaptive step length in staggered problem

Reimplemented in oofem::NLTransientTransportProblem, and oofem::NonLinearStatic.

Definition at line 579 of file engngm.h.

Referenced by oofem::AdditiveManufacturingProblem::giveDeltaT(), and oofem::StaggeredProblem::giveDeltaT().

◆ giveCurrentStep()

virtual TimeStep * oofem::EngngModel::giveCurrentStep ( bool force = false)
inlinevirtual

Returns current time step.

Parameters
forcewhen set to true then current step of receiver is returned instead of master (default)

Reimplemented in oofem::AdditiveManufacturingProblem, oofem::StaggeredProblem, and oofem::StaticStructural.

Definition at line 717 of file engngm.h.

References currentStep, and master.

Referenced by oofem::AdaptiveNonLinearStatic::adaptiveRemap(), oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::FE2FluidMaterial::computeDeviatoricStress3D(), oofem::NonLinearStatic::computeExternalLoadReactionContribution(), oofem::DIIDynamic::determineConstants(), drawElements(), drawNodes(), oofem::HuertaErrorEstimator::estimateError(), forceEquationNumbering(), oofem::FluidModel::forceEquationNumbering(), oofem::PFEM::forceEquationNumbering(), giveCurrentMetaStep(), oofem::DGProblem::giveField(), oofem::MPMProblem::giveField(), oofem::StationaryTransportProblem::giveField(), oofem::TransientTransportProblem::giveField(), oofem::AdaptiveNonLinearStatic::giveUnknownComponent(), oofem::DEIDynamic::giveUnknownComponent(), oofem::DIIDynamic::giveUnknownComponent(), oofem::FreeWarping::giveUnknownComponent(), oofem::LinearStatic::giveUnknownComponent(), oofem::NlDEIDynamic::giveUnknownComponent(), oofem::NLTransientTransportProblem::giveUnknownComponent(), oofem::NonLinearDynamic::giveUnknownComponent(), oofem::NonLinearStatic::giveUnknownComponent(), oofem::TestProblem::giveUnknownComponent(), oofem::PFEM::giveUnknownDictHashIndx(), oofem::SUPG::giveUnknownDictHashIndx(), oofem::AdaptiveNonLinearStatic::initializeAdaptiveFrom(), packRemoteElementData(), oofem::Subdivision::packRemoteElements(), oofem::PLMaterialForce::propagateInterface(), saveContext(), saveStepContext(), oofem::EigenValueDynamic::setActiveVector(), oofem::LinearStability::setActiveVector(), oofem::PatchIntegrationRule::SetUpPointsOnTriangle(), oofem::PatchIntegrationRule::SetUpPointsOnWedge(), oofem::HuertaErrorEstimator::setupRefinedProblemEpilog2(), oofem::HuertaErrorEstimator::setupRefinedProblemProlog(), oofem::AdditiveManufacturingProblem::solveYourself(), solveYourself(), oofem::LinearStability::solveYourself(), oofem::StaggeredProblem::solveYourself(), oofem::AdaptiveNonLinearStatic::solveYourselfAt(), oofem::CBS::solveYourselfAt(), oofem::SUPG::solveYourselfAt(), unpackRemoteElementData(), and oofem::XfemStructuralElementInterface::XfemElementInterface_updateIntegrationRule().

◆ giveDeltaT()

double oofem::EngngModel::giveDeltaT ( )
inline

Returns time step size from the time step controlelr.

Definition at line 424 of file engngm.h.

◆ giveDescription()

const std::string & oofem::EngngModel::giveDescription ( ) const
inline

Definition at line 367 of file engngm.h.

References simulationDescription.

◆ giveDomain()

Domain * oofem::EngngModel::giveDomain ( int n)

Service for accessing particular problem domain. Generates error if no such domain is defined.

Parameters
nPointer to n-th domain is returned.
Returns
Domain number n.

Definition at line 1936 of file engngm.C.

References domainList, and OOFEM_ERROR.

Referenced by oofem::AdaptiveNonLinearStatic::adaptiveRemap(), oofem::AdditiveManufacturingProblem::add_element_if_not_exists2(), oofem::AdditiveManufacturingProblem::add_node_if_not_exists2(), oofem::AdditiveManufacturingProblem::add_sm_element_if_not_exists2(), oofem::AdditiveManufacturingProblem::add_sm_node_if_not_exists2(), oofem::CBS::applyIC(), oofem::DGProblem::applyIC(), oofem::MPMProblem::applyIC(), oofem::NLTransientTransportProblem::applyIC(), oofem::NonStationaryTransportProblem::applyIC(), oofem::PFEM::applyIC(), oofem::SUPG::applyIC(), oofem::TransientTransportProblem::applyIC(), oofem::StokesFlowVelocityHomogenization::applyPressureGradient(), oofem::NLTransientTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::NonStationaryTransportProblem::assembleAlgorithmicPartOfRhs(), oofem::AdaptiveNonLinearStatic::assembleInitialLoadVector(), balanceLoad(), oofem::CompCol::buildInternalStructure(), oofem::DynCompCol::buildInternalStructure(), oofem::DynCompRow::buildInternalStructure(), oofem::PetscSparseMtrx::buildInternalStructure(), oofem::PetscSparseMtrx::buildInternalStructure(), oofem::Skyline::buildInternalStructure(), oofem::SkylineUnsym::buildInternalStructure(), oofem::SymCompCol::buildInternalStructure(), oofem::StructuralEngngModel::buildReactionTable(), oofem::CBS::checkConsistency(), oofem::FluidMaterialEvaluator::checkConsistency(), oofem::NonStationaryTransportProblem::checkConsistency(), oofem::PFEM::checkConsistency(), oofem::StationaryTransportProblem::checkConsistency(), oofem::StokesFlow::checkConsistency(), oofem::StructuralEngngModel::checkConsistency(), oofem::StructuralMaterialEvaluator::checkConsistency(), oofem::SUPG::checkConsistency(), oofem::TransientTransportProblem::checkConsistency(), oofem::SolutionbasedShapeFunction::computeBaseFunctionValueAt(), oofem::FreeWarping::computeCenterOfGravity(), oofem::SolutionbasedShapeFunction::computeCorrectionFactors(), oofem::StaticStructural::computeExternalLoadReactionContribution(), oofem::StructuralEngngModel::computeExternalLoadReactionContribution(), oofem::NlDEIDynamic::computeLoadVector(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::StructuralEngngModel::computeReaction(), oofem::FreeWarping::computeResultAtCenterOfGravity(), oofem::StokesFlowVelocityHomogenization::computeSeepage(), oofem::StokesFlowVelocityHomogenization::computeTangent(), oofem::InteractionLoad::computeValueAt(), oofem::DGProblem::constructBoundaryEntities(), oofem::StructuralFE2MaterialStatus::copyStateVariables(), oofem::NonStationaryTransportProblem::copyUnknownsInDictionary(), oofem::QClinearStatic::createInterpolationMeshNodes(), oofem::PFEM::deactivateTooCloseParticles(), oofem::FluidMaterialEvaluator::doStepOutput(), oofem::LinearStability::doStepOutput(), oofem::StokesFlow::doStepOutput(), oofem::StructuralMaterialEvaluator::doStepOutput(), drawElements(), drawNodes(), oofem::FreeWarping::estimateMaxPackSize(), oofem::LinearStatic::estimateMaxPackSize(), oofem::NlDEIDynamic::estimateMaxPackSize(), oofem::NonLinearDynamic::estimateMaxPackSize(), oofem::NonLinearStatic::estimateMaxPackSize(), oofem::StaticStructural::estimateMaxPackSize(), oofem::SUPG::evaluateElementStabilizationCoeffs(), forceEquationNumbering(), oofem::FluidModel::forceEquationNumbering(), oofem::PFEM::forceEquationNumbering(), oofem::QClinearStatic::generateInterpolationMesh(), oofem::StokesFlowVelocityHomogenization::giveAreaOfRVE(), oofem::InteractionPFEMParticle::giveCoupledVelocities(), oofem::DGProblem::giveDeltaT(), oofem::MPMProblem::giveDeltaT(), oofem::TransientTransportProblem::giveDeltaT(), oofem::AdditiveManufacturingProblem::giveDtFunction(), oofem::NonLinearStatic::giveDtFunction(), oofem::NonStationaryTransportProblem::giveDtFunction(), oofem::StaggeredProblem::giveDtFunction(), giveField(), oofem::AdaptiveNonLinearStatic::giveLoadBalancer(), oofem::NonLinearDynamic::giveLoadBalancer(), oofem::NonLinearStatic::giveLoadBalancer(), oofem::CBS::giveNextStep(), oofem::PFEM::giveNextStep(), oofem::SUPG::giveNextStep(), oofem::CBS::giveNumericalMethod(), oofem::DGProblem::giveNumericalMethod(), oofem::DIIDynamic::giveNumericalMethod(), oofem::EigenValueDynamic::giveNumericalMethod(), oofem::FreeWarping::giveNumericalMethod(), oofem::IncrementalLinearStatic::giveNumericalMethod(), oofem::LinearStability::giveNumericalMethod(), oofem::LinearStatic::giveNumericalMethod(), oofem::MPMProblem::giveNumericalMethod(), oofem::NlDEIDynamic::giveNumericalMethod(), oofem::NonLinearDynamic::giveNumericalMethod(), oofem::NonLinearStatic::giveNumericalMethod(), oofem::NonStationaryTransportProblem::giveNumericalMethod(), oofem::PFEM::giveNumericalMethod(), oofem::StationaryMPMSProblem::giveNumericalMethod(), oofem::StationaryTransportProblem::giveNumericalMethod(), oofem::StokesFlow::giveNumericalMethod(), oofem::SUPG::giveNumericalMethod(), oofem::TestProblem::giveNumericalMethod(), oofem::TransientTransportProblem::giveNumericalMethod(), oofem::LinearStability::giveNumericalMethodForLinStaticProblem(), oofem::InteractionPFEMParticle::givePrescribedUnknownVector(), oofem::SolutionbasedShapeFunction::giveValueAtPoint(), oofem::Natural2GlobalOrdering::init(), oofem::Natural2LocalOrdering::init(), oofem::oofegGraphicContext::init(), oofem::AdaptiveNonLinearStatic::initializeAdaptive(), oofem::AdaptiveNonLinearStatic::initializeAdaptiveFrom(), oofem::CBS::initializeFrom(), initializeFrom(), oofem::Integral::initializeFrom(), oofem::SUPG::initializeFrom(), oofem::SolutionbasedShapeFunction::initializeSurfaceData(), oofem::DIIDynamic::initializeYourself(), oofem::NonLinearDynamic::initializeYourself(), oofem::StokesFlowVelocityHomogenization::integrateNMatrix(), oofem::QClinearStatic::loadInterpolationMesh(), operator=(), packDofManagers(), oofem::NonLinearDynamic::packMigratingData(), oofem::NonLinearStatic::packMigratingData(), packRemoteElementData(), oofem::DGProblem::postInitialize(), oofem::QClinearStatic::postInitialize(), oofem::StationaryMPMSProblem::postInitialize(), oofem::TestProblem::postInitialize(), oofem::PFEM::preInitializeNextStep(), oofem::AdaptiveLinearStatic::printOutputAt(), oofem::DGProblem::printOutputAt(), oofem::EigenValueDynamic::printOutputAt(), oofem::FreeWarping::printOutputAt(), oofem::LinearStability::printOutputAt(), oofem::MPMProblem::printOutputAt(), oofem::NlDEIDynamic::printOutputAt(), oofem::NonLinearDynamic::printOutputAt(), oofem::NonLinearStatic::printOutputAt(), oofem::StructuralEngngModel::printOutputAt(), oofem::TransientTransportProblem::printOutputAt(), oofem::StructuralEngngModel::printReactionForces(), oofem::NonLinearDynamic::proceedStep(), oofem::NonLinearStatic::proceedStep(), oofem::XfemSolverInterface::propagateXfemInterfaces(), oofem::DGProblem::requiresEquationRenumbering(), oofem::MPMProblem::requiresEquationRenumbering(), oofem::StaticStructural::requiresEquationRenumbering(), oofem::TransientTransportProblem::requiresEquationRenumbering(), oofem::oofegGraphicContext::setActiveProblem(), oofem::SolutionbasedShapeFunction::setLoads(), oofem::ElementCommunicator::setUpCommunicationMaps(), oofem::FETICommunicator::setUpCommunicationMaps(), oofem::NodeCommunicator::setUpCommunicationMaps(), oofem::NonLinearDynamic::showSparseMtrxStructure(), oofem::NonLinearStatic::showSparseMtrxStructure(), oofem::StructuralEngngModel::showSparseMtrxStructure(), oofem::AdditiveManufacturingProblem::solveYourself(), oofem::EigenValueDynamic::solveYourself(), oofem::FluidMaterialEvaluator::solveYourself(), oofem::StructuralMaterialEvaluator::solveYourself(), oofem::AdaptiveNonLinearStatic::solveYourselfAt(), oofem::CBS::solveYourselfAt(), oofem::DEIDynamic::solveYourselfAt(), oofem::DGProblem::solveYourselfAt(), oofem::DIIDynamic::solveYourselfAt(), oofem::FluidStructureProblem::solveYourselfAt(), oofem::FreeWarping::solveYourselfAt(), oofem::IncrementalLinearStatic::solveYourselfAt(), oofem::LinearStability::solveYourselfAt(), oofem::LinearStatic::solveYourselfAt(), oofem::MPMProblem::solveYourselfAt(), oofem::NlDEIDynamic::solveYourselfAt(), oofem::NLTransientTransportProblem::solveYourselfAt(), oofem::NonStationaryTransportProblem::solveYourselfAt(), oofem::Pdelta::solveYourselfAt(), oofem::PFEM::solveYourselfAt(), oofem::QClinearStatic::solveYourselfAt(), oofem::StaticStructural::solveYourselfAt(), oofem::StationaryTransportProblem::solveYourselfAt(), oofem::StokesFlow::solveYourselfAt(), oofem::SUPG::solveYourselfAt(), oofem::TestProblem::solveYourselfAt(), oofem::TransientTransportProblem::solveYourselfAt(), oofem::LinearStability::terminateLinStatic(), unpackDofManagers(), oofem::NonLinearDynamic::unpackMigratingData(), oofem::NonLinearStatic::unpackMigratingData(), unpackRemoteElementData(), oofem::NonLinearDynamic::updateComponent(), oofem::StationaryTransportProblem::updateComponent(), oofem::FreeWarping::updateComputedResults(), oofem::SUPG::updateDofUnknownsDictionary_corrector(), oofem::SUPG::updateDofUnknownsDictionary_predictor(), oofem::AdaptiveLinearStatic::updateDomainLinks(), oofem::AdaptiveNonLinearStatic::updateDomainLinks(), oofem::CBS::updateDomainLinks(), oofem::DGProblem::updateDomainLinks(), oofem::FreeWarping::updateDomainLinks(), oofem::LinearStatic::updateDomainLinks(), oofem::MPMProblem::updateDomainLinks(), oofem::NonLinearDynamic::updateDomainLinks(), oofem::NonLinearStatic::updateDomainLinks(), oofem::NonStationaryTransportProblem::updateDomainLinks(), oofem::StaticStructural::updateDomainLinks(), oofem::StationaryTransportProblem::updateDomainLinks(), oofem::TransientTransportProblem::updateDomainLinks(), oofem::SUPG::updateElementsForNewInterfacePosition(), oofem::NonLinearDynamic::updateInternalRHS(), oofem::StationaryTransportProblem::updateInternalRHS(), oofem::StationaryTransportProblem::updateMatrix(), oofem::SUPG::updateSolutionVectors(), oofem::SUPG::updateSolutionVectors_predictor(), oofem::FreeWarping::updateStiffnessMatrix(), and oofem::AdaptiveLinearStatic::updateYourself().

◆ giveDomainErrorEstimator()

virtual ErrorEstimator * oofem::EngngModel::giveDomainErrorEstimator ( int n)
inlinevirtual

Service for accessing ErrorEstimator corresponding to particular domain

Definition at line 372 of file engngm.h.

References defaultErrEstimator.

Referenced by oofem::NonLinearDynamic::unpackMigratingData(), and oofem::NonLinearStatic::unpackMigratingData().

◆ giveDomainFileName()

std::string oofem::EngngModel::giveDomainFileName ( int domainNum,
int domainSerNum ) const

Returns the filename for the given domain (used by adaptivity and restore)

Parameters
domainNumDomain number.
domainSerNumDomain serial number.

Definition at line 1917 of file engngm.C.

References coreOutputFileName.

Referenced by oofem::AdaptiveNonLinearStatic::initializeAdaptive().

◆ giveEigenValue()

virtual double oofem::EngngModel::giveEigenValue ( int eigNum)
inlinevirtual

Only relevant for eigen value analysis. Otherwise returns zero.

Reimplemented in oofem::EigenValueDynamic, and oofem::LinearStability.

Definition at line 556 of file engngm.h.

Referenced by oofem::EigenValueErrorCheckingRule::check(), and oofem::EigenValueErrorCheckingRule::getValue().

◆ giveEndOfTimeOfInterest()

virtual double oofem::EngngModel::giveEndOfTimeOfInterest ( )
inlinevirtual

Returns end of time interest (time corresponding to end of time integration).

Reimplemented in oofem::IncrementalLinearStatic, and oofem::StaticStructural.

Definition at line 785 of file engngm.h.

◆ giveEngngModel()

EngngModel * oofem::EngngModel::giveEngngModel ( )
inline

Returns reference to itself -> required by communicator.h.

Definition at line 1213 of file engngm.h.

References EngngModel().

◆ giveEquationScalingFlag()

virtual bool oofem::EngngModel::giveEquationScalingFlag ( )
inlinevirtual

Returns the Equation scaling flag, which is used to indicate that governing equation(s) are scaled, or non-dimensionalized.

Reimplemented in oofem::CBS, and oofem::SUPG.

Definition at line 1181 of file engngm.h.

◆ giveExportModuleManager()

ExportModuleManager * oofem::EngngModel::giveExportModuleManager ( )
inline

Returns receiver's export module manager.

Definition at line 791 of file engngm.h.

References exportModuleManager.

Referenced by balanceLoad(), oofem::AdditiveManufacturingProblem::solveYourself(), oofem::StokesFlow::solveYourselfAt(), and updateDomainLinks().

◆ giveField() [1/2]

virtual FieldPtr oofem::EngngModel::giveField ( FieldType key,
TimeStep *  )
inlinevirtual

Returns the smart pointer to requested field, Null otherwise. The return value uses shared_ptr, as some registered fields may be owned (and maintained) by emodel, while some may be created on demand and thus reliable reference counting mechanism is essential.

Reimplemented in oofem::AdditiveManufacturingProblem, oofem::DGProblem, oofem::MPMProblem, oofem::StaticStructural, oofem::StationaryTransportProblem, and oofem::TransientTransportProblem.

Definition at line 545 of file engngm.h.

Referenced by oofem::SADGBoundaryElement::giveCharacteristicMatrix().

◆ giveField() [2/2]

FieldPtr oofem::EngngModel::giveField ( InternalStateType key,
TimeStep *  )
virtual

Definition at line 2106 of file engngm.C.

References giveDomain(), and oofem::NodalRecoveryModel::NRM_ZienkiewiczZhu.

◆ giveFinalTime()

virtual double oofem::EngngModel::giveFinalTime ( )
inlinevirtual

Returns final time of the simulation

Reimplemented in oofem::DGProblem, and oofem::MPMProblem.

Definition at line 801 of file engngm.h.

References timeStepController.

◆ giveFormulation()

virtual fMode oofem::EngngModel::giveFormulation ( )
inlinevirtual

Indicates type of non linear computation (total or updated formulation). This is used for example on Nodal level to update coordinates if updated formulation is done, or on element level, when non linear contributions are computed.

Reimplemented in oofem::AdditiveManufacturingProblem, oofem::CBS, oofem::DEIDynamic, oofem::DGProblem, oofem::DIIDynamic, oofem::FluidStructureProblem, oofem::FreeWarping, oofem::IncrementalLinearStatic, oofem::LinearStability, oofem::LinearStatic, oofem::MPMProblem, oofem::NlDEIDynamic, oofem::NLTransientTransportProblem, oofem::NonLinearDynamic, oofem::NonLinearStatic, oofem::NonStationaryTransportProblem, oofem::PFEM, oofem::QClinearStatic, oofem::StaggeredProblem, oofem::StationaryMPMSProblem, oofem::StationaryTransportProblem, oofem::SUPG, oofem::TestProblem, and oofem::TransientTransportProblem.

Definition at line 1165 of file engngm.h.

References nonLinFormulation.

Referenced by oofem::GradientDamageElement::computeStiffnessMatrix_du(), oofem::GradDpElement::computeStiffnessMatrix_ku(), oofem::GradientDamageElement::computeStiffnessMatrix_ud(), oofem::GradDpElement::computeStiffnessMatrix_uk(), oofem::GradDpElement::computeStiffnessMatrix_uu(), oofem::GradientDamageElement::computeStiffnessMatrix_uu(), oofem::GradientDamageElement::computeStressVector_and_localDamageDrivingVariable(), oofem::GradDpElement::computeStressVectorAndLocalCumulatedStrain(), oofem::GradientDamageElement::giveInternalForcesVector_u(), and oofem::GradDpElement::giveLocalInternalForcesVector().

◆ giveInitialTime()

virtual double oofem::EngngModel::giveInitialTime ( )
inlinevirtual

return time at the begining of analysis

Reimplemented in oofem::AdaptiveNonLinearStatic, oofem::NlDEIDynamic, and oofem::NonLinearStatic.

Definition at line 797 of file engngm.h.

Referenced by solveYourself().

◆ giveLoadBalancer()

virtual LoadBalancer * oofem::EngngModel::giveLoadBalancer ( )
inlinevirtual

Returns reference to receiver's load balancer.

Reimplemented in oofem::AdaptiveNonLinearStatic, oofem::NonLinearDynamic, and oofem::NonLinearStatic.

Definition at line 1206 of file engngm.h.

Referenced by balanceLoad(), and updateAttributes().

◆ giveLoadBalancerMonitor()

virtual LoadBalancerMonitor * oofem::EngngModel::giveLoadBalancerMonitor ( )
inlinevirtual

Returns reference to receiver's load balancer monitor.

Reimplemented in oofem::AdaptiveNonLinearStatic, oofem::NonLinearDynamic, and oofem::NonLinearStatic.

Definition at line 1208 of file engngm.h.

Referenced by balanceLoad(), and updateAttributes().

◆ giveLoadLevel()

virtual double oofem::EngngModel::giveLoadLevel ( )
inlinevirtual

◆ giveMasterEngngModel()

EngngModel * oofem::EngngModel::giveMasterEngngModel ( )
inline

Returns the master engnmodel.

Definition at line 550 of file engngm.h.

References EngngModel().

◆ giveMaterialInterface()

virtual MaterialInterface * oofem::EngngModel::giveMaterialInterface ( int n)
inlinevirtual

Returns material interface representation for given domain

Reimplemented in oofem::SUPG.

Definition at line 374 of file engngm.h.

◆ giveMetaStep()

◆ giveNewEquationNumber()

virtual int oofem::EngngModel::giveNewEquationNumber ( int domain,
DofIDItem  )
inlinevirtual

Increases number of equations of receiver's domain and returns newly created equation number. Used mainly by DofManagers to allocate their corresponding equation number if it is not currently allocated. The DofIDItem parameter allows to distinguish between several possible governing equations, that can be numbered separately.

Reimplemented in oofem::CBS, and oofem::PFEM.

Definition at line 813 of file engngm.h.

References domainNeqs.

Referenced by oofem::ActiveDof::askNewEquationNumber(), and oofem::MasterDof::askNewEquationNumber().

◆ giveNewPrescribedEquationNumber()

virtual int oofem::EngngModel::giveNewPrescribedEquationNumber ( int domain,
DofIDItem  )
inlinevirtual

Increases number of prescribed equations of receiver's domain and returns newly created equation number. Used mainly by DofManagers to allocate their corresponding equation number if it is not currently allocated. The DofIDItem parameter allows to distinguish between several possible governing equations, that can be numbered separately.

Reimplemented in oofem::CBS, and oofem::PFEM.

Definition at line 821 of file engngm.h.

References domainPrescribedNeqs.

Referenced by oofem::ActiveDof::askNewEquationNumber(), and oofem::MasterDof::askNewEquationNumber().

◆ giveNextStep()

◆ giveNumberOfDomainEquations()

int oofem::EngngModel::giveNumberOfDomainEquations ( int di,
const UnknownNumberingScheme & num )
virtual

Returns number of equations for given domain in active (current time step) time step. The numbering scheme determines which system the result is requested for.

Reimplemented in oofem::CBS, and oofem::PFEM.

Definition at line 452 of file engngm.C.

References domainNeqs, domainPrescribedNeqs, equationNumberingCompleted, forceEquationNumbering(), and oofem::UnknownNumberingScheme::isDefault().

Referenced by oofem::AdaptiveNonLinearStatic::adaptiveRemap(), oofem::NonStationaryTransportProblem::applyIC(), oofem::SUPG::applyIC(), oofem::DIIDynamic::assembleDirichletBcRhsVector(), assembleExtrapolatedForces(), oofem::NonLinearStatic::assembleIncrementalReferenceLoadVectors(), oofem::AdaptiveNonLinearStatic::assembleInitialLoadVector(), oofem::DIIDynamic::assembleLoadVector(), assemblePrescribedExtrapolatedForces(), oofem::CompCol::buildInternalStructure(), oofem::DynCompCol::buildInternalStructure(), oofem::DynCompRow::buildInternalStructure(), oofem::PetscSparseMtrx::buildInternalStructure(), oofem::PetscSparseMtrx::buildInternalStructure(), oofem::Skyline::buildInternalStructure(), oofem::SkylineUnsym::buildInternalStructure(), oofem::SpoolesSparseMtrx::buildInternalStructure(), oofem::SymCompCol::buildInternalStructure(), oofem::StructuralEngngModel::buildReactionTable(), oofem::StaticStructural::computeExternalLoadReactionContribution(), oofem::StructuralEngngModel::computeExternalLoadReactionContribution(), oofem::PrescribedGenStrainShell7::computeField(), oofem::PrescribedGradient::computeField(), oofem::TransportGradientDirichlet::computeField(), oofem::MixedGradientPressureDirichlet::computeFields(), oofem::NlDEIDynamic::computeLoadVector(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::StructuralEngngModel::computeReaction(), oofem::PrescribedDispSlipBCDirichletRC::computeStress(), oofem::StokesFlowVelocityHomogenization::computeTangent(), oofem::Natural2GlobalOrdering::init(), oofem::Natural2LocalOrdering::init(), oofem::AdaptiveNonLinearStatic::initializeAdaptiveFrom(), oofem::DIIDynamic::initializeYourself(), oofem::NonLinearDynamic::initializeYourself(), oofem::EIPrimaryUnknownMapper::mapAndUpdate(), oofem::LSPrimaryVariableMapper::mapPrimaryVariables(), oofem::TransientTransportProblem::printOutputAt(), oofem::NonLinearDynamic::proceedStep(), oofem::NonLinearStatic::proceedStep(), solveYourself(), oofem::FreeWarping::solveYourself(), oofem::LinearStatic::solveYourself(), oofem::NlDEIDynamic::solveYourself(), oofem::NonLinearDynamic::solveYourself(), oofem::NonLinearStatic::solveYourself(), oofem::StaticStructural::solveYourself(), oofem::DEIDynamic::solveYourselfAt(), oofem::DGProblem::solveYourselfAt(), oofem::DIIDynamic::solveYourselfAt(), oofem::FreeWarping::solveYourselfAt(), oofem::IncrementalLinearStatic::solveYourselfAt(), oofem::LinearStability::solveYourselfAt(), oofem::LinearStatic::solveYourselfAt(), oofem::MPMProblem::solveYourselfAt(), oofem::NlDEIDynamic::solveYourselfAt(), oofem::NLTransientTransportProblem::solveYourselfAt(), oofem::NonLinearDynamic::solveYourselfAt(), oofem::NonStationaryTransportProblem::solveYourselfAt(), oofem::Pdelta::solveYourselfAt(), oofem::StaticStructural::solveYourselfAt(), oofem::StationaryMPMSProblem::solveYourselfAt(), oofem::StationaryTransportProblem::solveYourselfAt(), oofem::StokesFlow::solveYourselfAt(), oofem::SUPG::solveYourselfAt(), oofem::TestProblem::solveYourselfAt(), oofem::TransientTransportProblem::solveYourselfAt(), oofem::DIIDynamic::timesMtrx(), oofem::NonLinearDynamic::timesMtrx(), oofem::NonLinearDynamic::unpackMigratingData(), oofem::NonLinearStatic::unpackMigratingData(), and oofem::StructuralEngngModel::updateInternalRHS().

◆ giveNumberOfDomains()

int oofem::EngngModel::giveNumberOfDomains ( )
inline

Returns number of domains in problem.

Definition at line 365 of file engngm.h.

References domainList.

Referenced by forceEquationNumbering(), oofem::oofegGraphicContext::init(), initParallelContexts(), and oofem::oofegGraphicContext::setActiveProblem().

◆ giveNumberOfFirstStep()

◆ giveNumberOfMetaSteps()

int oofem::EngngModel::giveNumberOfMetaSteps ( )
inline

Return number of meta steps.

Definition at line 771 of file engngm.h.

Referenced by oofem::AdditiveManufacturingProblem::solveYourself(), and oofem::StaggeredProblem::solveYourself().

◆ giveNumberOfProcesses()

◆ giveNumberOfSlaveProblems()

virtual int oofem::EngngModel::giveNumberOfSlaveProblems ( )
inlinevirtual

Returns number of slave problems.

Reimplemented in oofem::AdditiveManufacturingProblem, oofem::FluidStructureProblem, oofem::ProblemSequence, and oofem::StaggeredProblem.

Definition at line 1176 of file engngm.h.

◆ giveNumberOfSteps()

int oofem::EngngModel::giveNumberOfSteps ( bool force = false)
inline

Returns total number of steps.

Parameters
forcewhen set to true then receiver reply is returned instead of master (default)

Definition at line 777 of file engngm.h.

References master, and timeStepController.

Referenced by oofem::StaticStructural::giveEndOfTimeOfInterest(), oofem::AdaptiveNonLinearStatic::giveTimeStepLoadLevel(), printYourself(), and oofem::AdaptiveNonLinearStatic::updateYourself().

◆ giveNumberOfTimeStepWhenIcApply()

◆ giveNumericalMethod()

◆ giveOutputBaseFileName()

◆ giveOutputStream()

◆ giveParallelComm()

MPI_Comm oofem::EngngModel::giveParallelComm ( )
inline

Returns the communication object of reciever.

Definition at line 583 of file engngm.h.

◆ giveParallelContext()

ParallelContext * oofem::EngngModel::giveParallelContext ( int n)
virtual

Returns the parallel context corresponding to given domain (n) and unknown type Default implementation returns i-th context from parallelContextList.

Definition at line 1961 of file engngm.C.

References OOFEM_ERROR, and parallelContextList.

Referenced by assembleVector(), and oofem::PetscSparseMtrx::buildInternalStructure().

◆ givePreviousStep()

virtual TimeStep * oofem::EngngModel::givePreviousStep ( bool force = false)
inlinevirtual

◆ giveProblemCommunicator()

ProblemCommunicator * oofem::EngngModel::giveProblemCommunicator ( EngngModelCommType t)
inline

Definition at line 625 of file engngm.h.

References communicator, nonlocCommunicator, PC_default, and PC_nonlocal.

Referenced by oofem::Subdivision::packRemoteElements().

◆ giveProblemMode()

problemMode oofem::EngngModel::giveProblemMode ( ) const
inline

Returns domain mode.

Definition at line 440 of file engngm.h.

References pMode.

Referenced by instanciateYourself().

◆ giveProblemScale()

problemScale oofem::EngngModel::giveProblemScale ( ) const
inline

Returns scale in multiscale simulation.

Definition at line 447 of file engngm.h.

References pScale.

Referenced by oofem::StaticStructural::solveYourselfAt(), oofem::StokesFlow::solveYourselfAt(), and oofem::Tr21Stokes::Tr21Stokes().

◆ giveRank()

int oofem::EngngModel::giveRank ( ) const
inline

Returns domain rank in a group of collaborating processes (0..groupSize-1).

Definition at line 1154 of file engngm.h.

References rank.

Referenced by balanceLoad(), oofem::PetscSparseMtrx::buildInternalStructure(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::T3DInterface::createInput(), oofem::LoadBalancer::deleteRemoteDofManagers(), oofem::LoadBalancer::deleteRemoteElements(), oofem::HuertaErrorEstimator::estimateError(), exchangeRemoteElementData(), oofem::Natural2GlobalOrdering::init(), oofem::NonlocalMaterialWTP::init(), oofem::NodalAveragingRecoveryModel::initCommMaps(), oofem::SPRNodalRecoveryModel::initCommMaps(), oofem::ZZNodalRecoveryModel::initCommMaps(), oofem::DirectErrorIndicatorRC::initializeFrom(), oofem::FreeWarping::initializeFrom(), oofem::LinearStatic::initializeFrom(), oofem::NlDEIDynamic::initializeFrom(), oofem::NonLinearDynamic::initializeFrom(), oofem::NonLinearStatic::initializeFrom(), oofem::QClinearStatic::initializeFrom(), oofem::StaticStructural::initializeFrom(), oofem::ParallelOrdering::isLocal(), oofem::NonlocalMaterialWTP::migrate(), oofem::LoadBalancer::migrateLoad(), oofem::LoadBalancer::packMigratingData(), oofem::NonlocalMaterialWTP::packMigratingElementDependencies(), oofem::NonlocalMaterialWTP::packRemoteElements(), oofem::LoadBalancer::printStatistics(), oofem::FreeWarping::solveYourself(), oofem::LinearStatic::solveYourself(), oofem::NlDEIDynamic::solveYourself(), oofem::NonLinearDynamic::solveYourself(), oofem::NonLinearStatic::solveYourself(), oofem::StaticStructural::solveYourself(), oofem::NonLinearDynamic::solveYourselfAt(), oofem::LoadBalancer::unpackMigratingData(), oofem::NonlocalMaterialWTP::unpackMigratingElementDependencies(), oofem::NonlocalMaterialWTP::unpackRemoteElements(), oofem::Subdivision::unpackRemoteElements(), and updateSharedDofManagers().

◆ giveReferenceFileName()

std::string oofem::EngngModel::giveReferenceFileName ( )
inline

Returns reference file name.

Definition at line 391 of file engngm.h.

References referenceFileName.

◆ giveSlaveProblem()

virtual EngngModel * oofem::EngngModel::giveSlaveProblem ( int i)
inlinevirtual

Returns i-th slave problem.

Reimplemented in oofem::AdditiveManufacturingProblem, oofem::ProblemSequence, and oofem::StaggeredProblem.

Definition at line 1178 of file engngm.h.

References EngngModel().

◆ giveSolutionStepTime()

double oofem::EngngModel::giveSolutionStepTime ( )

Returns the user time of the current simulation step in seconds.

Definition at line 2005 of file engngm.C.

References timer.

Referenced by oofem::EigenValueDynamic::solveYourself(), and solveYourself().

◆ giveSolutionStepWhenIcApply()

virtual TimeStep * oofem::EngngModel::giveSolutionStepWhenIcApply ( bool force = false)
inlinevirtual

Returns the solution step when Initial Conditions (IC) apply.

Parameters
forcewhen set to true then receiver reply is returned instead of master (default)

Reimplemented in oofem::AdditiveManufacturingProblem, oofem::CBS, oofem::DGProblem, oofem::MPMProblem, oofem::NonLinearStatic, oofem::NonStationaryTransportProblem, oofem::PFEM, oofem::StaggeredProblem, oofem::SUPG, and oofem::TransientTransportProblem.

Definition at line 753 of file engngm.h.

References master, and stepWhenIcApply.

◆ giveStartTime()

const time_t & oofem::EngngModel::giveStartTime ( )
inline

Definition at line 368 of file engngm.h.

References startTime.

◆ giveSuppressOutput()

bool oofem::EngngModel::giveSuppressOutput ( ) const
inline

Definition at line 369 of file engngm.h.

References suppressOutput.

Referenced by oofem::Domain::Domain().

◆ giveTimer()

EngngModelTimer * oofem::EngngModel::giveTimer ( )
inline

Returns reference to receiver timer (EngngModelTimer).

Definition at line 793 of file engngm.h.

References timer.

Referenced by oofem::LoadBalancer::printStatistics().

◆ giveTimeStepController()

TimeStepController * oofem::EngngModel::giveTimeStepController ( )
inline

Returns the time step controller.

Definition at line 1217 of file engngm.h.

◆ giveUnknownComponent()

virtual double oofem::EngngModel::giveUnknownComponent ( ValueModeType ,
TimeStep * ,
Domain * ,
Dof *  )
inlinevirtual

◆ giveUnknownDictHashIndx()

virtual int oofem::EngngModel::giveUnknownDictHashIndx ( ValueModeType mode,
TimeStep * tStep )
inlinevirtual

This method is responsible for computing unique dictionary id (ie hash value) from given valueModeType and time step. This function is used by particular dofs to access unknown identified by given parameters from its dictionary using computed index. Usually the hash algorithm should produce index that depend on time step relatively to actual one to avoid storage of complete history.

Reimplemented in oofem::CBS, oofem::DGProblem, oofem::EigenValueDynamic, oofem::IncrementalLinearStatic, oofem::LinearStability, oofem::MPMProblem, oofem::NLTransientTransportProblem, oofem::NonLinearDynamic, oofem::NonLinearStatic, oofem::NonStationaryTransportProblem, oofem::PFEM, oofem::StaticStructural, oofem::SUPG, and oofem::TransientTransportProblem.

Definition at line 930 of file engngm.h.

◆ giveVariableScale()

virtual double oofem::EngngModel::giveVariableScale ( VarScaleType varId)
inlinevirtual

Returns the scale factor for given variable type.

Reimplemented in oofem::CBS, and oofem::SUPG.

Definition at line 1183 of file engngm.h.

Referenced by oofem::PFEM::giveNextStep().

◆ init()

void oofem::EngngModel::init ( )
virtual

Initializes the receiver state. Default implementation calls initModuleManager::doInit service to invoke initialization by individual init modules.

Definition at line 2082 of file engngm.C.

References initModuleManager.

Referenced by oofem::DEIDynamic::solveYourselfAt().

◆ initForNewIteration()

void oofem::EngngModel::initForNewIteration ( Domain * d,
TimeStep * tStep,
int iterationNumber,
const FloatArray & solution )
virtual

◆ initializeAdaptive()

virtual int oofem::EngngModel::initializeAdaptive ( int tStepNumber)
inlinevirtual

Initializes the newly generated discretization state according to previous solution. This process should typically include restoring old solution, instanciating newly generated domain(s) and by mapping procedure.

Reimplemented in oofem::AdaptiveLinearStatic, oofem::AdaptiveNonLinearStatic, oofem::AdditiveManufacturingProblem, oofem::FluidStructureProblem, and oofem::StaggeredProblem.

Definition at line 521 of file engngm.h.

◆ initializeCommMaps()

◆ initializeFrom()

void oofem::EngngModel::initializeFrom ( InputRecord & ir)
virtual

Initializes receiver according to object description in input reader. InitString can be imagined as data record in component database belonging to receiver. Receiver may use value-name extracting functions to extract particular field from record.

Reimplemented in oofem::AdaptiveLinearStatic, oofem::AdaptiveNonLinearStatic, oofem::AdditiveManufacturingProblem, oofem::CBS, oofem::DEIDynamic, oofem::DGProblem, oofem::DIIDynamic, oofem::DummyEngngModel, oofem::EigenValueDynamic, oofem::FluidMaterialEvaluator, oofem::FluidStructureProblem, oofem::FreeWarping, oofem::IncrementalLinearStatic, oofem::LinearStability, oofem::LinearStatic, oofem::MPMProblem, oofem::NlDEIDynamic, oofem::NLTransientTransportProblem, oofem::NonLinearDynamic, oofem::NonLinearStatic, oofem::NonStationaryTransportProblem, oofem::Pdelta, oofem::PFEM, oofem::ProblemSequence, oofem::QClinearStatic, oofem::StaggeredProblem, oofem::StaticStructural, oofem::StationaryMPMSProblem, oofem::StationaryTransportProblem, oofem::StokesFlow, oofem::StructuralMaterialEvaluator, oofem::SUPG, oofem::TestProblem, and oofem::TransientTransportProblem.

Definition at line 292 of file engngm.C.

References _IFT_EngngModel_contextoutputstep, _IFT_EngngModel_eetype, _IFT_EngngModel_forceloadBalancingFlag, _IFT_EngngModel_loadBalancingFlag, _IFT_EngngModel_nmsteps, _IFT_EngngModel_nonLinFormulation, _IFT_EngngModel_nsteps, _IFT_EngngModel_parallelflag, _IFT_EngngModel_profileOpt, _IFT_EngngModel_renumberFlag, _IFT_EngngModel_suppressOutput, oofem::classFactory, oofem::InputRecord::clone(), contextOutputStep, dataOutputFileName, defaultErrEstimator, force_load_rebalance_in_first_step, giveDomain(), oofem::DataReader::giveGroupRecords(), oofem::InputRecord::giveReader(), oofem::InputRecord::hasField(), IR_GIVE_OPTIONAL_FIELD, oofem::DataReader::IR_mstepRec, isParallel(), loadBalancingFlag, nMetaSteps, nonLinFormulation, numberOfSteps, numProcs, OOFEM_ERROR, outputStream, parallelFlag, PRG_HEADER, processor_name, profileOpt, rank, renumberFlag, setUDContextOutputMode(), simulationDescription, oofem::DataReader::GroupRecords::size(), startTime, and suppressOutput.

Referenced by oofem::StationaryMPMSProblem::initializeFrom(), oofem::TestProblem::initializeFrom(), and instanciateYourself().

◆ initializeYourself()

void oofem::EngngModel::initializeYourself ( TimeStep * tStep)
virtual

Provides the opportunity to initialize state variables stored in element integration points according to initial conditions using function initializeYourself() on element level. Should be called when current time step is time step when IC will apply (see EngngModel::giveNumberOfTimeStepWhenIcApply) somewhere from solveYourselfAt function). Implementation must be provided. Default implementation is empty.

Reimplemented in oofem::AdditiveManufacturingProblem, oofem::DIIDynamic, oofem::FluidStructureProblem, oofem::NonLinearDynamic, and oofem::StaggeredProblem.

Definition at line 561 of file engngm.C.

References domainList.

Referenced by solveYourself().

◆ initMetaStepAttributes()

void oofem::EngngModel::initMetaStepAttributes ( MetaStep * mStep)
inline

Update e-model attributes attributes according to step metaStep attributes. Calls updateAttributes. At the end the meta step input reader finish() service is called in order to allow for unread attribute check.

Definition at line 677 of file engngm.h.

Referenced by oofem::AdditiveManufacturingProblem::solveYourself(), oofem::StaggeredProblem::solveYourself(), oofem::StokesFlow::solveYourselfAt(), and oofem::SUPG::solveYourselfAt().

◆ initParallel()

void oofem::EngngModel::initParallel ( )

Request domain rank and problem size.

Definition at line 2089 of file engngm.C.

References comm, numProcs, OOFEM_ERROR, OOFEM_LOG_RELEVANT, processor_name, and rank.

Referenced by setParallelMode().

◆ initParallelContexts()

void oofem::EngngModel::initParallelContexts ( )
virtual

Creates parallel contexts. Must be implemented by derived classes since the governing equation type is required for context creation.

Definition at line 1971 of file engngm.C.

References giveNumberOfDomains(), and parallelContextList.

Referenced by Instanciate_init().

◆ initStepIncrements()

void oofem::EngngModel::initStepIncrements ( )
virtual

Initializes solution of new time step. Default implementation resets all internal history variables (in integration points of elements) to previously reached equilibrium values. Can be used for time step restart.

Definition at line 1702 of file engngm.C.

References domainList, and oofem::Element_remote.

Referenced by oofem::AdaptiveNonLinearStatic::adaptiveRemap(), oofem::AdaptiveNonLinearStatic::initializeAdaptive(), restoreContext(), and solveYourself().

◆ Instanciate_init()

void oofem::EngngModel::Instanciate_init ( )

Initialization of the receiver state (opening the default output stream, empty domain creation, initialization of parallel context, etc) before Initialization form DataReader. Called at the beginning of instanciateYourself.

Parameters
dataOutputFileNameName of default output stream

Definition at line 184 of file engngm.C.

References domainList, domainNeqs, domainPrescribedNeqs, initParallelContexts(), and ndomains.

Referenced by instanciateYourself().

◆ instanciateDefaultMetaStep()

int oofem::EngngModel::instanciateDefaultMetaStep ( InputRecord & ir)
virtual

Instanciate default metastep, if nmsteps is zero.

Reimplemented in oofem::AdditiveManufacturingProblem, and oofem::ProblemSequence.

Definition at line 405 of file engngm.C.

References metaStepList, nMetaSteps, numberOfSteps, and OOFEM_ERROR.

Referenced by instanciateYourself().

◆ instanciateDomains()

int oofem::EngngModel::instanciateDomains ( DataReader & dr)

Instanciate problem domains by calling their instanciateYourself() service.

Definition at line 366 of file engngm.C.

References domainList, oofem::DataReader::giveInputRecord(), oofem::DataReader::IR_domainRec, and postInitialize().

Referenced by instanciateYourself().

◆ instanciateMetaSteps()

int oofem::EngngModel::instanciateMetaSteps ( DataReader & dr)

Instanciate problem meta steps by calling their instanciateYourself() service.

Definition at line 382 of file engngm.C.

References oofem::DataReader::giveGroupRecords(), oofem::DataReader::IR_mstepRec, metaStepList, nMetaSteps, and numberOfSteps.

◆ instanciateYourself()

int oofem::EngngModel::instanciateYourself ( DataReader & dr,
InputRecord & ir,
const char * outFileName,
const char * desc )
virtual

◆ isElementActivated() [1/2]

virtual bool oofem::EngngModel::isElementActivated ( Element * e)
inlinevirtual

Reimplemented in oofem::QClinearStatic.

Definition at line 1215 of file engngm.h.

◆ isElementActivated() [2/2]

virtual bool oofem::EngngModel::isElementActivated ( int elemNum)
inlinevirtual

Reimplemented in oofem::QClinearStatic.

Definition at line 1214 of file engngm.h.

Referenced by oofem::QuasicontinuumVTKXMLExportModule::initRegionNodeNumbering().

◆ isParallel()

bool oofem::EngngModel::isParallel ( ) const
inline

Returns true if receiver in parallel mode.

Definition at line 1152 of file engngm.h.

References parallelFlag.

Referenced by oofem::AdaptiveNonLinearStatic::adaptiveRemap(), assembleVector(), assembleVectorFromElements(), oofem::PetscSparseMtrx::buildInternalStructure(), oofem::BeamElementErrorCheckingRule::check(), oofem::ElementErrorCheckingRule::check(), oofem::InternalElementDofManErrorCheckingRule::check(), oofem::NodeErrorCheckingRule::check(), oofem::ReactionErrorCheckingRule::check(), oofem::T3DInterface::createInput(), errorInfo(), exchangeRemoteElementData(), oofem::BeamElementErrorCheckingRule::getValue(), oofem::ElementErrorCheckingRule::getValue(), oofem::InternalElementDofManErrorCheckingRule::getValue(), oofem::NodeErrorCheckingRule::getValue(), oofem::ReactionErrorCheckingRule::getValue(), oofem::DGProblem::giveNumericalMethod(), oofem::FreeWarping::giveNumericalMethod(), oofem::LinearStatic::giveNumericalMethod(), oofem::TestProblem::giveNumericalMethod(), oofem::AdditiveManufacturingProblem::initializeFrom(), initializeFrom(), oofem::FreeWarping::initializeFrom(), oofem::LinearStatic::initializeFrom(), oofem::NonLinearDynamic::initializeFrom(), oofem::NonLinearStatic::initializeFrom(), oofem::QClinearStatic::initializeFrom(), oofem::StaggeredProblem::initializeFrom(), oofem::StaticStructural::initializeFrom(), oofem::FreeWarping::solveYourself(), oofem::LinearStatic::solveYourself(), oofem::NlDEIDynamic::solveYourself(), oofem::NonLinearDynamic::solveYourself(), oofem::NonLinearStatic::solveYourself(), oofem::StaticStructural::solveYourself(), oofem::NonLinearDynamic::solveYourselfAt(), and updateSharedDofManagers().

◆ letOutputBaseFileNameBe()

void oofem::EngngModel::letOutputBaseFileNameBe ( const std ::string & src)

Sets the base output file name.

See also
giveOutputBaseFileName
Parameters
srcNew output file name.

Definition at line 1980 of file engngm.C.

References dataOutputFileName, OOFEM_ERROR, outputStream, and suppressOutput.

◆ newDofHandling()

virtual bool oofem::EngngModel::newDofHandling ( )
inlinevirtual

Temporary method for allowing code to seamlessly convert from the old to new way of handling DOF values. (the new way expects the field to store all values, regardless of if they are computed, from BC, or IC.) This is used by MasterDof

Todo
When all models have converted to using a field, this should be removed.

Reimplemented in oofem::CBS, oofem::DGProblem, oofem::EigenValueDynamic, oofem::LinearStability, oofem::MPMProblem, oofem::StaticStructural, oofem::StokesFlow, and oofem::TransientTransportProblem.

Definition at line 937 of file engngm.h.

◆ operator=()

EngngModel & oofem::EngngModel::operator= ( const EngngModel & )
delete

◆ outputElements()

void oofem::EngngModel::outputElements ( FILE * file,
Domain & domain,
TimeStep * tStep,
int setNum )

Outputs all elements in the given set.

Parameters
fileOutput stream.
domainDomain.
tStepTime step.
setNumSet number. If zero, outputs all elements.

Definition at line 852 of file engngm.C.

References oofem::Element_remote, oofem::Domain::giveElement(), oofem::Set::giveElementList(), oofem::Domain::giveElements(), oofem::Domain::giveSet(), and oofem::Element::printOutputAt().

Referenced by printOutputAt().

◆ outputNodes()

void oofem::EngngModel::outputNodes ( FILE * file,
Domain & domain,
TimeStep * tStep,
int setNum )

Outputs all nodes in the given set.

Parameters
fileOutput stream.
domainDomain.
tStepTime step.
setNumSet number. If zero, outputs all elements.

Definition at line 825 of file engngm.C.

References oofem::DofManager_null, oofem::Domain::giveDofManager(), oofem::Domain::giveDofManagers(), oofem::Set::giveNodeList(), oofem::Domain::giveSet(), and oofem::DofManager::printOutputAt().

Referenced by printOutputAt().

◆ packDofManagers()

int oofem::EngngModel::packDofManagers ( ArrayWithNumbering * src,
ProcessCommunicator & processComm )

Packing function for vector values of DofManagers. Packs vector values of shared/remote DofManagers into send communication buffer of given process communicator.

Parameters
processCommTask communicator.
srcSource vector + equation numbering.
Returns
Nonzero if successful.
Todo
Shouldn't hardcode domain number 1
Todo
Must fix: Internal dofmanagers in xfem and bc

Definition at line 2339 of file engngm.C.

References oofem::EngngModel::ArrayWithNumbering::array, oofem::FloatArray::at(), oofem::Domain::giveDofManager(), giveDomain(), oofem::ProcessCommunicator::giveProcessCommunicatorBuff(), oofem::ProcessCommunicator::giveToSendMap(), oofem::EngngModel::ArrayWithNumbering::numbering, and oofem::ProcessCommunicatorBuff::write().

◆ packMigratingData()

virtual void oofem::EngngModel::packMigratingData ( TimeStep * tStep)
inlineprotectedvirtual

Packs receiver data when rebalancing load. When rebalancing happens, the local numbering will be lost on majority of processors. Instead of identifying values of solution vectors that have to be send/received and then performing renumbering, all solution vectors are assumed to be stored in dof dictionaries before data migration. Then dofs will take care themselves for packing and unpacking. After data migration and local renumbering, the solution vectors will be restored from dof dictionary data back.

Reimplemented in oofem::NonLinearDynamic, and oofem::NonLinearStatic.

Definition at line 1077 of file engngm.h.

Referenced by balanceLoad().

◆ packRemoteElementData()

int oofem::EngngModel::packRemoteElementData ( ProcessCommunicator & processComm)

Packs data of local element to be received by their remote counterpart on remote partitions. Remote elements are introduced when nonlocal constitutive models are used, in order to allow local averaging procedure (remote elements, which are involved in averaging on local partition are mirrored on this local partition) instead of implementing inefficient fine-grain communication. Remote element data are exchanged only if necessary and once for all of them. Current implementation calls packUnknowns service for all elements listed in given process communicator send map.

Parameters
processCommCorresponding process communicator.
Returns
Nonzero if successful.

Definition at line 2300 of file engngm.C.

References giveCurrentStep(), giveDomain(), oofem::Domain::giveElement(), oofem::ProcessCommunicator::giveProcessCommunicatorBuff(), oofem::ProcessCommunicatorBuff::giveSendBuff(), oofem::ProcessCommunicator::giveToSendMap(), and oofem::Element::packUnknowns().

◆ postInitialize()

void oofem::EngngModel::postInitialize ( )
virtual

Performs post-initialization for all the problem contents (which is called after initializeFrom). Currently, it calls Domain::postInitialize for all problem domains.

Reimplemented in oofem::DGProblem, oofem::QClinearStatic, oofem::StationaryMPMSProblem, and oofem::TestProblem.

Definition at line 2072 of file engngm.C.

References domainList, and timeStepController.

Referenced by instanciateDomains(), oofem::StationaryMPMSProblem::postInitialize(), and oofem::TestProblem::postInitialize().

◆ preInitializeNextStep()

virtual void oofem::EngngModel::preInitializeNextStep ( )
inlinevirtual

Does a pre-initialization of the next time step (implement if necessarry).

Reimplemented in oofem::FluidStructureProblem, and oofem::PFEM.

Definition at line 749 of file engngm.h.

Referenced by oofem::AdditiveManufacturingProblem::solveYourself(), solveYourself(), and oofem::StaggeredProblem::solveYourself().

◆ printDofOutputAt()

void oofem::EngngModel::printDofOutputAt ( FILE * stream,
Dof * iDof,
TimeStep * tStep )
virtual

DOF printing routine. Called by DofManagers to print Dof specific part. Dof class provides component printing routines, but emodel is responsible for what will be printed at DOF level.

Parameters
streamoutput stream
iDofdof to be processed
tStepsolution step

Reimplemented in oofem::CBS, oofem::DEIDynamic, oofem::DIIDynamic, oofem::FluidStructureProblem, oofem::NlDEIDynamic, oofem::NonLinearDynamic, oofem::PFEM, and oofem::SUPG.

Definition at line 884 of file engngm.C.

References oofem::Dof::printSingleOutputAt().

Referenced by oofem::ClonedDofManager::printOutputAt(), oofem::DofManager::printOutputAt(), and oofem::qcNode::printOutputAt().

◆ printOutputAt() [1/2]

void oofem::EngngModel::printOutputAt ( FILE * file,
TimeStep * tStep )
virtual

Prints output of receiver to output domain stream, for given time step. Corresponding function for element gauss points is invoked (gaussPoint::printOutputAt).

Reimplemented in oofem::AdaptiveLinearStatic, oofem::AdditiveManufacturingProblem, oofem::DGProblem, oofem::EigenValueDynamic, oofem::FreeWarping, oofem::LinearStability, oofem::MPMProblem, oofem::NlDEIDynamic, oofem::NonLinearDynamic, oofem::NonLinearStatic, oofem::StaggeredProblem, oofem::StructuralEngngModel, and oofem::TransientTransportProblem.

Definition at line 781 of file engngm.C.

References domainList, oofem::TimeStep::giveTargetTime(), and oofem::VST_Time.

Referenced by doStepOutput().

◆ printOutputAt() [2/2]

void oofem::EngngModel::printOutputAt ( FILE * file,
TimeStep * tStep,
const IntArray & nodeSets,
const IntArray & elementSets )
virtual
Todo
Add general support for reaction forces

Definition at line 806 of file engngm.C.

References oofem::IntArray::at(), domainList, oofem::IntArray::giveSize(), outputElements(), and outputNodes().

◆ printYourself()

void oofem::EngngModel::printYourself ( )

Prints state of receiver. Useful for debugging.

Definition at line 877 of file engngm.C.

References giveClassName(), giveNumberOfSteps(), and numberOfEquations.

◆ requiresEquationRenumbering()

virtual bool oofem::EngngModel::requiresEquationRenumbering ( TimeStep * tStep)
inlinevirtual

Returns true if equation renumbering is required for given solution step. This may of course change the number of equation and in general there is no guarantee that for a certain dof the same equation will be assigned. So the use of DOF unknowns dictionaries is generally recommended.

Reimplemented in oofem::DGProblem, oofem::IncrementalLinearStatic, oofem::MPMProblem, oofem::NonStationaryTransportProblem, oofem::StaticStructural, and oofem::TransientTransportProblem.

Definition at line 915 of file engngm.h.

References renumberFlag.

Referenced by oofem::AdditiveManufacturingProblem::solveYourself(), solveYourself(), and oofem::StaggeredProblem::solveYourself().

◆ requiresUnknownsDictionaryUpdate()

virtual int oofem::EngngModel::requiresUnknownsDictionaryUpdate ( )
inlinevirtual

Indicates if EngngModel requires Dofs dictionaries to be updated. If EngngModel does not support changes of static system, the dof forwards the requests for its unknowns to EngngModel, where unknowns are naturally kept. This is possible, because dof equation number is same during whole solution. But when changes of static system are allowed, several problem arise. For example by solving simple incremental static with allowed static changes, the incremental displacement vector of structure can not be added to total displacement vector of structure, because equation numbers may have changed, and one can not simply add these vector to obtain new total displacement vector, because incompatible displacement will be added. To solve this problem, unknown dictionary at dof level has been assumed. Dof then keeps its unknowns in its own private dictionary. After computing increment of solution, engngModel updates for each dof its unknowns in its dictionary (using updateUnknownsDictionary function). For aforementioned example engngModel updates incremental values but also total value by asking dof for previous total value (dof will use its dictionary, does not asks back EngngModel) adds corresponding increment and updates total value in dictionary.

Reimplemented in oofem::DGProblem, oofem::IncrementalLinearStatic, oofem::MPMProblem, oofem::NonStationaryTransportProblem, oofem::PFEM, oofem::StaticStructural, oofem::SUPG, and oofem::TransientTransportProblem.

Definition at line 908 of file engngm.h.

Referenced by oofem::EigenValueDynamic::printOutputAt(), and oofem::StructuralEngngModel::updateInternalState().

◆ resetRenumberFlag()

virtual void oofem::EngngModel::resetRenumberFlag ( )
inlinevirtual

Sets the renumber flag to false.

Definition at line 451 of file engngm.h.

◆ restartYourself()

virtual void oofem::EngngModel::restartYourself ( TimeStep * tS)
inlinevirtual

This method is called when the restart of the analysis is perfomed, e.g., du to the convergence problems, and does all the necesary steps for the restart. These steps are handled by the individual engineering models

Reimplemented in oofem::StaticStructural.

Definition at line 477 of file engngm.h.

Referenced by solveYourself().

◆ restoreContext()

void oofem::EngngModel::restoreContext ( DataStream & stream,
ContextMode mode )
virtual

Restores the state of model from output stream. Restores not only the receiver state, but also same function is invoked for all DofManagers and Elements in associated domain. Note that by restoring element context also contexts of all associated integration points (and material statuses) are restored. Each context is associated with unique time step. Only one context per time step is allowed. Restore context function will restore such context, which is related (through its step number) to time step number and version given in obj parameter. Restoring context will change current time step in order to correspond to newly restored context.

Parameters
streamContext file.
modeDetermines amount of info in stream.
Exceptions
ContextIOERRexception if error encountered.

Reimplemented in oofem::AdaptiveLinearStatic, oofem::AdaptiveNonLinearStatic, oofem::AdditiveManufacturingProblem, oofem::CBS, oofem::DGProblem, oofem::DIIDynamic, oofem::EigenValueDynamic, oofem::IncrementalLinearStatic, oofem::LinearStability, oofem::LinearStatic, oofem::MPMProblem, oofem::NlDEIDynamic, oofem::NonLinearDynamic, oofem::NonLinearStatic, oofem::NonStationaryTransportProblem, oofem::PFEM, oofem::ProblemSequence, oofem::StaggeredProblem, oofem::StaticStructural, oofem::StationaryTransportProblem, oofem::SUPG, and oofem::TransientTransportProblem.

Definition at line 1814 of file engngm.C.

References oofem::CIO_IOERR, oofem::CIO_OK, currentStep, domainList, domainNeqs, domainPrescribedNeqs, giveCurrentMetaStep(), giveMetaStep(), giveNumericalMethod(), initStepIncrements(), nMetaSteps, numberOfEquations, numberOfPrescribedEquations, previousStep, oofem::DataStream::read(), renumberFlag, oofem::NumericalMethod::restoreContext(), THROW_CIOERR, updateAttributes(), and updateDomainLinks().

Referenced by oofem::HuertaErrorEstimator::estimateError().

◆ saveContext()

void oofem::EngngModel::saveContext ( DataStream & stream,
ContextMode mode )
virtual

Stores the state of model to output stream. Stores not only the receiver state, but also same function is invoked for all DofManagers and Elements in associated domain. Note that by storing element context also contexts of all associated integration points (and material statuses) are stored.

Parameters
streamContext stream.
modeDetermines amount of info in stream.
Exceptions
ContextIOERRIf error encountered.

Reimplemented in oofem::AdaptiveNonLinearStatic, oofem::AdditiveManufacturingProblem, oofem::CBS, oofem::DGProblem, oofem::DIIDynamic, oofem::EigenValueDynamic, oofem::IncrementalLinearStatic, oofem::LinearStability, oofem::LinearStatic, oofem::MPMProblem, oofem::NlDEIDynamic, oofem::NonLinearDynamic, oofem::NonLinearStatic, oofem::NonStationaryTransportProblem, oofem::PFEM, oofem::ProblemSequence, oofem::StaggeredProblem, oofem::StaticStructural, oofem::StationaryTransportProblem, oofem::SUPG, and oofem::TransientTransportProblem.

Definition at line 1755 of file engngm.C.

References oofem::CIO_IOERR, oofem::CIO_OK, domainList, domainNeqs, domainPrescribedNeqs, giveCurrentStep(), giveMetaStep(), giveNumericalMethod(), numberOfEquations, numberOfPrescribedEquations, renumberFlag, oofem::NumericalMethod::saveContext(), THROW_CIOERR, and oofem::DataStream::write().

Referenced by saveStepContext().

◆ saveStepContext()

void oofem::EngngModel::saveStepContext ( TimeStep * tStep,
ContextMode mode )

Saves context of given solution step, if required (determined using this->giveContextOutputMode() method).

Definition at line 768 of file engngm.C.

References oofem::COM_Always, oofem::COM_Required, oofem::COM_UserDefined, giveContextFileName(), giveContextOutputMode(), giveCurrentStep(), oofem::TimeStep::giveNumber(), and saveContext().

Referenced by terminate(), and oofem::NonLinearStatic::terminate().

◆ setActiveVector()

virtual void oofem::EngngModel::setActiveVector ( int i)
inlinevirtual

Only relevant for eigen value analysis. Otherwise does noting.

Reimplemented in oofem::EigenValueDynamic, and oofem::LinearStability.

Definition at line 558 of file engngm.h.

◆ setContextOutputMode()

void oofem::EngngModel::setContextOutputMode ( ContextOutputMode contextMode)
inline

Sets context output mode of receiver.

Parameters
contextModedomain context mode.

Definition at line 411 of file engngm.h.

References contextOutputMode.

Referenced by oofem::AdaptiveNonLinearStatic::solveYourselfAt().

◆ setDeltaT()

void oofem::EngngModel::setDeltaT ( double dT)
inline

Returns time step size through the time step controlelr.

Definition at line 426 of file engngm.h.

◆ setDomain()

void oofem::EngngModel::setDomain ( int i,
Domain * ptr,
bool iDeallocateOld = true )

Sets i-th domain of receiver. Given domain is assumed to be owned (and deleted) by receiver. The old domain, if defined, will be deleted.

Parameters
iDomain index.
ptrPointer to valid domain instance.

Definition at line 1948 of file engngm.C.

References domainList, and OOFEM_ERROR.

Referenced by operator=().

◆ setNumberOfEquations()

void oofem::EngngModel::setNumberOfEquations ( int id,
int neq )
inline

Definition at line 375 of file engngm.h.

References domainNeqs, and numberOfEquations.

◆ setParallelMode()

void oofem::EngngModel::setParallelMode ( bool newParallelFlag)

Sets the problem to run in parallel (or not).

Parameters
parallelFlagDetermines parallel mode.

Definition at line 174 of file engngm.C.

References initParallel(), and parallelFlag.

◆ setProblemMode()

void oofem::EngngModel::setProblemMode ( problemMode pmode)
inline

Sets domain mode to given mode.

Parameters
pmodeProblem mode.

Definition at line 433 of file engngm.h.

References pMode.

◆ setProblemScale()

void oofem::EngngModel::setProblemScale ( problemScale pscale)
inline

Sets scale in multiscale simulation.

Parameters
pscaleProblem scale.

Definition at line 445 of file engngm.h.

References pScale.

◆ setRenumberFlag()

virtual void oofem::EngngModel::setRenumberFlag ( )
inlinevirtual

Sets the renumber flag to true.

Reimplemented in oofem::AdditiveManufacturingProblem, and oofem::StaggeredProblem.

Definition at line 449 of file engngm.h.

◆ setUDContextOutputMode()

void oofem::EngngModel::setUDContextOutputMode ( int cStep)
inline

Sets user defined context output mode (it sets contextOutputMode to contextOutputMode), setting contextOutputStep to given value.

Parameters
cStepnew context output step

Definition at line 418 of file engngm.h.

References oofem::COM_UserDefined, contextOutputMode, and contextOutputStep.

Referenced by initializeFrom().

◆ showSparseMtrxStructure()

virtual void oofem::EngngModel::showSparseMtrxStructure ( int type,
oofegGraphicContext & gc,
TimeStep * tStep )
inlinevirtual

Shows the sparse structure of required matrix, type == 1 stiffness.

Reimplemented in oofem::AdditiveManufacturingProblem, oofem::FluidStructureProblem, oofem::NonLinearDynamic, oofem::NonLinearStatic, oofem::ProblemSequence, oofem::StaggeredProblem, and oofem::StructuralEngngModel.

Definition at line 1226 of file engngm.h.

References gc.

◆ solveYourself()

◆ solveYourselfAt()

◆ terminate()

void oofem::EngngModel::terminate ( TimeStep * tStep)
virtual

Terminates the solution of time step. Default implementation calls prinOutput() service and if specified, context of whole domain is stored and output for given time step is printed.

Reimplemented in oofem::AdditiveManufacturingProblem, oofem::NonLinearStatic, oofem::StaggeredProblem, oofem::StaticStructural, and oofem::StructuralEngngModel.

Definition at line 741 of file engngm.C.

References CM_Definition, CM_State, doStepOutput(), exportModuleManager, giveOutputStream(), monitorManager, saveStepContext(), suppressOutput, and oofem::Monitor::TimeStepTermination.

Referenced by oofem::EigenValueDynamic::solveYourself(), and solveYourself().

◆ terminateAnalysis()

void oofem::EngngModel::terminateAnalysis ( )

Performs analysis termination after finishing analysis.

Definition at line 2022 of file engngm.C.

References exportModuleManager, giveAnalysisTime(), giveOutputStream(), OOFEM_LOG_FORCED, suppressOutput, and timer.

Referenced by oofem::AdaptiveNonLinearStatic::solveYourselfAt().

◆ unpackDofManagers()

int oofem::EngngModel::unpackDofManagers ( ArrayWithNumbering * dest,
ProcessCommunicator & processComm )

Unpacking function for vector values of DofManagers . Unpacks vector of shared/remote DofManagers from receive communication buffer of given process communicator.

Parameters
processCommTask communicator.
destDestination vector + equation numbering.
Returns
Nonzero if successful.
Todo
Shouldn't hardcode domain number 1
Todo
Must fix: Internal dofmanagers in bc

Definition at line 2367 of file engngm.C.

References oofem::EngngModel::ArrayWithNumbering::array, oofem::FloatArray::at(), oofem::DofManager_remote, oofem::DofManager_shared, oofem::Domain::giveDofManager(), giveDomain(), oofem::DofManager::giveParallelMode(), oofem::ProcessCommunicator::giveProcessCommunicatorBuff(), oofem::ProcessCommunicator::giveToRecvMap(), oofem::EngngModel::ArrayWithNumbering::numbering, OOFEM_ERROR, and oofem::ProcessCommunicatorBuff::read().

◆ unpackMigratingData()

virtual void oofem::EngngModel::unpackMigratingData ( TimeStep * tStep)
inlineprotectedvirtual

Unpacks receiver data when rebalancing load. When rebalancing happens, the local numbering will be lost on majority of processors. Instead of identifying values of solution vectors that have to be send/received and then performing renumbering, all solution vectors are assumed to be stored in dof dictionaries before data migration. Then dofs will take care themselves for packing and unpacking. After data migration and local renumbering, the solution vectors will be restored from dof dictionary data back.

Reimplemented in oofem::NonLinearDynamic, and oofem::NonLinearStatic.

Definition at line 1084 of file engngm.h.

Referenced by balanceLoad().

◆ unpackRemoteElementData()

int oofem::EngngModel::unpackRemoteElementData ( ProcessCommunicator & processComm)

Unpacks data for remote elements (which are mirrors of remote partition's local elements). Remote elements are introduced when nonlocal constitutive models are used, in order to allow local averaging procedure (remote elements, which are involved in averaging on local partition are mirrored on this local partition) instead of implementing inefficient fine-grain communication. Remote element data are exchanged only if necessary and once for all of them. Current implementation calls unpackAndUpdateUnknowns service for all elements listed in given process communicator receive map.

Parameters
processCommCorresponding process communicator.
Returns
Nonzero if successful.

Definition at line 2317 of file engngm.C.

References oofem::Element_remote, giveCurrentStep(), giveDomain(), oofem::Domain::giveElement(), oofem::Element::giveParallelMode(), oofem::ProcessCommunicator::giveProcessCommunicatorBuff(), oofem::ProcessCommunicatorBuff::giveRecvBuff(), oofem::ProcessCommunicator::giveToRecvMap(), OOFEM_ERROR, and oofem::Element::unpackAndUpdateUnknowns().

◆ updateAttributes()

void oofem::EngngModel::updateAttributes ( MetaStep * mStep)
virtual

Update receiver attributes according to step metaStep attributes. Allows the certain parameters or attributes to be updated for particular metastep. The metastep provides the attributes record, from which the corresponding attributes can be read. The service takes a MetaStep parameter. It is recommended, to implement this service in such way, that multiple calls for steps belonging to same MetaStep does not change response. The default implementation updates the numerical method attributes.

Parameters
mStepMeta step.

Reimplemented in oofem::AdditiveManufacturingProblem, oofem::NonLinearDynamic, oofem::NonLinearStatic, oofem::StaggeredProblem, and oofem::StaticStructural.

Definition at line 669 of file engngm.C.

References oofem::MetaStep::giveAttributesRecord(), giveLoadBalancer(), giveLoadBalancerMonitor(), oofem::MetaStep::giveNumber(), giveNumericalMethod(), and timeStepController.

Referenced by restoreContext(), oofem::EigenValueDynamic::solveYourself(), and oofem::LinearStability::solveYourself().

◆ updateComponent()

◆ updateDofUnknownsDictionary()

virtual void oofem::EngngModel::updateDofUnknownsDictionary ( DofManager * ,
TimeStep *  )
inlinevirtual

◆ updateDomainLinks()

void oofem::EngngModel::updateDomainLinks ( )
virtual

Updates domain links after the domains of receiver have changed. Used mainly after restoring context - the domains may change and this service is then used to update domain variables in all components belonging to receiver like error estimators, solvers, etc, having domains as attributes.

Reimplemented in oofem::AdaptiveLinearStatic, oofem::AdaptiveNonLinearStatic, oofem::AdditiveManufacturingProblem, oofem::CBS, oofem::DGProblem, oofem::FreeWarping, oofem::LinearStatic, oofem::MPMProblem, oofem::NonLinearDynamic, oofem::NonLinearStatic, oofem::NonStationaryTransportProblem, oofem::StaggeredProblem, oofem::StaticStructural, oofem::StationaryTransportProblem, oofem::SUPG, and oofem::TransientTransportProblem.

Definition at line 1749 of file engngm.C.

References giveExportModuleManager().

Referenced by restoreContext().

◆ updateInternalRHS()

void oofem::EngngModel::updateInternalRHS ( FloatArray & answer,
TimeStep * tStep,
Domain * d,
FloatArray * eNorm )
virtual

Updates the solution (guess) according to the new values. Callback for nonlinear solvers (e.g. Newton-Raphson).

Parameters
solutionVectorNew solution.
tStepTime when component is updated.
dDomain.
eNormOptional per-element norm (for normalization).

Reimplemented in oofem::DGProblem, oofem::MPMProblem, oofem::NonLinearDynamic, oofem::StaticStructural, oofem::StationaryTransportProblem, oofem::StokesFlow, oofem::StructuralEngngModel, oofem::SUPG, and oofem::TransientTransportProblem.

Definition at line 1688 of file engngm.C.

References OOFEM_ERROR.

◆ updateMatrix()

void oofem::EngngModel::updateMatrix ( SparseMtrx & mat,
TimeStep * tStep,
Domain * d )
virtual

Updates the solution (guess) according to the new values. Callback for nonlinear solvers (e.g. Newton-Raphson).

Note
For performance, the matrix should keep it's non-zero structure between calls, so the caller should make sure not to clear the matrix object before called.
Parameters
solutionVectorNew solution.
tStepTime when component is updated.
dDomain.

Reimplemented in oofem::DGProblem, oofem::MPMProblem, oofem::NonLinearDynamic, oofem::NonLinearStatic, oofem::StaticStructural, oofem::StationaryTransportProblem, oofem::StokesFlow, oofem::SUPG, and oofem::TransientTransportProblem.

Definition at line 1695 of file engngm.C.

References OOFEM_ERROR.

◆ updateSharedDofManagers()

int oofem::EngngModel::updateSharedDofManagers ( FloatArray & answer,
const UnknownNumberingScheme & s,
int ExchangeTag )

Exchanges necessary remote DofManagers data.

Todo
The name and description of this function is misleading, the function really just accumulates the total values for shared "equations".
Parameters
answerArray with collected values.
ExchangeTagExchange tag used by communicator.
Returns
Nonzero if successful.

Definition at line 2162 of file engngm.C.

References oofem::EngngModel::ArrayWithNumbering::array, communicator, giveRank(), isParallel(), oofem::EngngModel::ArrayWithNumbering::numbering, OOFEM_ERROR, and VERBOSEPARALLEL_PRINT.

Referenced by oofem::NonLinearStatic::assembleIncrementalReferenceLoadVectors(), oofem::DIIDynamic::assembleLoadVector(), oofem::NlDEIDynamic::computeLoadVector(), oofem::NlDEIDynamic::computeMassMtrx(), oofem::StructuralEngngModel::computeReaction(), oofem::NonLinearDynamic::proceedStep(), oofem::DEIDynamic::solveYourselfAt(), oofem::FreeWarping::solveYourselfAt(), oofem::IncrementalLinearStatic::solveYourselfAt(), oofem::LinearStability::solveYourselfAt(), oofem::LinearStatic::solveYourselfAt(), oofem::MPMProblem::solveYourselfAt(), oofem::Pdelta::solveYourselfAt(), oofem::StaticStructural::solveYourselfAt(), oofem::StationaryMPMSProblem::solveYourselfAt(), oofem::StationaryTransportProblem::solveYourselfAt(), oofem::StokesFlow::solveYourselfAt(), oofem::SUPG::solveYourselfAt(), oofem::TransientTransportProblem::solveYourselfAt(), oofem::NonLinearDynamic::timesMtrx(), oofem::MPMProblem::updateComponent(), oofem::StaticStructural::updateComponent(), oofem::StationaryMPMSProblem::updateComponent(), oofem::StationaryTransportProblem::updateComponent(), oofem::StokesFlow::updateComponent(), oofem::SUPG::updateComponent(), oofem::TransientTransportProblem::updateComponent(), oofem::MPMProblem::updateInternalRHS(), oofem::StaticStructural::updateInternalRHS(), oofem::StationaryTransportProblem::updateInternalRHS(), oofem::StokesFlow::updateInternalRHS(), oofem::StructuralEngngModel::updateInternalRHS(), oofem::SUPG::updateInternalRHS(), and oofem::TransientTransportProblem::updateInternalRHS().

◆ updateSolution()

void oofem::EngngModel::updateSolution ( FloatArray & solutionVector,
TimeStep * tStep,
Domain * d )
virtual

Updates the solution (guess) according to the new values. Callback for nonlinear solvers (e.g. Newton-Raphson), and are called before new internal forces are computed.

Parameters
solutionVectorNew solution.
tStepTime when component is updated.
dDomain.

Reimplemented in oofem::DGProblem, oofem::MPMProblem, oofem::NonLinearDynamic, oofem::NonLinearStatic, oofem::StaticStructural, oofem::StationaryMPMSProblem, oofem::StationaryTransportProblem, oofem::StokesFlow, oofem::SUPG, and oofem::TransientTransportProblem.

Definition at line 1681 of file engngm.C.

References OOFEM_ERROR.

Referenced by initForNewIteration().

◆ updateYourself()

void oofem::EngngModel::updateYourself ( TimeStep * tStep)
virtual

Updates internal state after finishing time step. (for example total values may be updated according to previously solved increments). Then element values are also updated (together with related integration points and material statuses).

Reimplemented in oofem::AdaptiveLinearStatic, oofem::AdaptiveNonLinearStatic, oofem::AdditiveManufacturingProblem, oofem::CBS, oofem::DGProblem, oofem::DIIDynamic, oofem::EigenValueDynamic, oofem::LinearStability, oofem::MPMProblem, oofem::NlDEIDynamic, oofem::NLTransientTransportProblem, oofem::NonLinearDynamic, oofem::NonStationaryTransportProblem, oofem::PFEM, oofem::StaggeredProblem, oofem::StokesFlow, oofem::StructuralEngngModel, oofem::SUPG, and oofem::TransientTransportProblem.

Definition at line 692 of file engngm.C.

References domainList, oofem::Element_remote, and VERBOSE_PRINT0.

Referenced by solveYourself().

◆ useNonlocalStiffnessOption()

virtual int oofem::EngngModel::useNonlocalStiffnessOption ( )
inlinevirtual

Returns nonzero if nonlocal stiffness option activated.

Reimplemented in oofem::AdditiveManufacturingProblem, oofem::FluidStructureProblem, oofem::NonLinearDynamic, oofem::NonLinearStatic, and oofem::StaggeredProblem.

Definition at line 1150 of file engngm.h.

Referenced by oofem::SkylineUnsym::buildInternalStructure().

Member Data Documentation

◆ comm

MPI_Comm oofem::EngngModel::comm
protected

Communication object for this engineering model.

Definition at line 299 of file engngm.h.

Referenced by assembleVector(), EngngModel(), and initParallel().

◆ commBuff

◆ communicator

◆ context

EngngModelContext* oofem::EngngModel::context
protected

Context.

Definition at line 277 of file engngm.h.

Referenced by EngngModel(), oofem::FluidStructureProblem::showSparseMtrxStructure(), and ~EngngModel().

◆ contextOutputMode

◆ contextOutputStep

int oofem::EngngModel::contextOutputStep
protected

◆ coreOutputFileName

std::string oofem::EngngModel::coreOutputFileName
protected

String with core output file name.

Definition at line 250 of file engngm.h.

Referenced by giveContextFileName(), giveDomainFileName(), and instanciateYourself().

◆ currentStep

◆ dataOutputFileName

◆ defaultErrEstimator

◆ domainList

◆ domainNeqs

◆ domainPrescribedNeqs

◆ equationNumberingCompleted

◆ exportModuleManager

◆ force_load_rebalance_in_first_step

bool oofem::EngngModel::force_load_rebalance_in_first_step
protected

Debug flag forcing load balancing after first step.

Definition at line 309 of file engngm.h.

Referenced by balanceLoad(), EngngModel(), and initializeFrom().

◆ initModuleManager

InitModuleManager oofem::EngngModel::initModuleManager
protected

Initialization module manager.

Definition at line 262 of file engngm.h.

Referenced by EngngModel(), init(), and instanciateYourself().

◆ lb

◆ lbm

◆ loadBalancingFlag

◆ master

◆ metaStepList

std :: vector< MetaStep > oofem::EngngModel::metaStepList
protected

List of problem metasteps.

Definition at line 237 of file engngm.h.

Referenced by instanciateDefaultMetaStep(), instanciateMetaSteps(), and oofem::DGProblem::postInitialize().

◆ monitorManager

MonitorManager oofem::EngngModel::monitorManager
protected

Monitor manager.

Definition at line 264 of file engngm.h.

Referenced by EngngModel(), instanciateYourself(), and terminate().

◆ ndomains

◆ nMetaSteps

◆ nonLinFormulation

enum fMode oofem::EngngModel::nonLinFormulation
protected

◆ nonlocalExt

int oofem::EngngModel::nonlocalExt
protected

Flag indicating if nonlocal extension active, which will cause data to be sent between shared elements before computing the internal forces.

Definition at line 293 of file engngm.h.

Referenced by EngngModel(), exchangeRemoteElementData(), initializeCommMaps(), oofem::NlDEIDynamic::initializeFrom(), oofem::NonLinearDynamic::initializeFrom(), oofem::NonLinearStatic::initializeFrom(), oofem::StaticStructural::initializeFrom(), and oofem::StaticStructural::solveYourself().

◆ nonlocCommunicator

◆ number

int oofem::EngngModel::number
protected

Receivers id.

Definition at line 245 of file engngm.h.

Referenced by oofem::Domain::Domain(), and EngngModel().

◆ numberOfEquations

int oofem::EngngModel::numberOfEquations
protected

Total number of equation in current time step.

Definition at line 221 of file engngm.h.

Referenced by oofem::AdaptiveNonLinearStatic::adaptiveRemap(), EngngModel(), forceEquationNumbering(), printYourself(), restoreContext(), saveContext(), and setNumberOfEquations().

◆ numberOfPrescribedEquations

int oofem::EngngModel::numberOfPrescribedEquations
protected

Total number or prescribed equations in current time step.

Definition at line 223 of file engngm.h.

Referenced by oofem::AdaptiveNonLinearStatic::adaptiveRemap(), EngngModel(), forceEquationNumbering(), restoreContext(), and saveContext().

◆ numberOfSteps

◆ numProcs

int oofem::EngngModel::numProcs
protected

◆ outputStream

◆ parallelContextList

std :: vector< ParallelContext > oofem::EngngModel::parallelContextList
protected

List where parallel contexts are stored.

Definition at line 323 of file engngm.h.

Referenced by oofem::AdaptiveNonLinearStatic::adaptiveRemap(), forceEquationNumbering(), giveParallelContext(), and initParallelContexts().

◆ parallelFlag

int oofem::EngngModel::parallelFlag
protected

Flag indicating that the receiver runs in parallel.

Definition at line 281 of file engngm.h.

Referenced by EngngModel(), initializeFrom(), isParallel(), and setParallelMode().

◆ pMode

◆ previousStep

◆ processor_name

char oofem::EngngModel::processor_name[PROCESSOR_NAME_LENGTH]
protected

◆ profileOpt

bool oofem::EngngModel::profileOpt
protected

Profile optimized numbering flag (using Sloan's algorithm).

Definition at line 231 of file engngm.h.

Referenced by EngngModel(), forceEquationNumbering(), and initializeFrom().

◆ pScale

problemScale oofem::EngngModel::pScale
protected

◆ rank

int oofem::EngngModel::rank
protected

Domain rank in a group of collaborating processes (0..groupSize-1).

Definition at line 289 of file engngm.h.

Referenced by EngngModel(), errorInfo(), giveRank(), oofem::AdditiveManufacturingProblem::initializeFrom(), initializeFrom(), oofem::StaggeredProblem::initializeFrom(), and initParallel().

◆ referenceFileName

std::string oofem::EngngModel::referenceFileName
protected

String with reference file name.

Definition at line 254 of file engngm.h.

Referenced by EngngModel(), giveReferenceFileName(), and instanciateYourself().

◆ renumberFlag

bool oofem::EngngModel::renumberFlag
protected

◆ simulationDescription

◆ startTime

◆ stepWhenIcApply

◆ suppressOutput

◆ timer

◆ timeStepController

std::unique_ptr<TimeStepController> oofem::EngngModel::timeStepController
protected

Time Step controller is responsible for collecting data from analysis, elements, and materials, and select the appropriate timestep size for the next step, or reduce the step in case of convergence problems.

Definition at line 287 of file engngm.h.

Referenced by oofem::StaticStructural::adaptTimeStep(), EngngModel(), oofem::StaticStructural::giveCurrentStep(), giveFinalTime(), giveNumberOfSteps(), oofem::StaticStructural::givePreviousStep(), instanciateYourself(), postInitialize(), solveYourself(), and updateAttributes().


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

This page is part of the OOFEM-3.0 documentation. Copyright Copyright (C) 1994-2025 Borek Patzak Bořek Patzák
Project e-mail: oofem@fsv.cvut.cz
Generated at for OOFEM by doxygen 1.15.0 written by Dimitri van Heesch, © 1997-2011