www.mooseframework.org
Public Member Functions | Static Public Member Functions | Protected Member Functions | Protected Attributes | Private Types | Private Member Functions | Private Attributes | List of all members
ADPowerLawCreepExceptionTest< compute_stage > Class Template Reference

#include <ADPowerLawCreepExceptionTest.h>

Inheritance diagram for ADPowerLawCreepExceptionTest< compute_stage >:
[legend]

Public Member Functions

 ADPowerLawCreepExceptionTest (const InputParameters &parameters)
 
virtual void updateState (ADRankTwoTensor &strain_increment, ADRankTwoTensor &inelastic_strain_increment, const ADRankTwoTensor &rotation_increment, ADRankTwoTensor &stress_new, const RankTwoTensor &stress_old, const ADRankFourTensor &elasticity_tensor, const RankTwoTensor &elastic_strain_old) override
 A radial return (J2) mapping method is performed with return mapping iterations. More...
 
virtual Real computeReferenceResidual (const ADReal &effective_trial_stress, const ADReal &scalar_effective_inelastic_strain) override
 Compute a reference quantity to be used for checking relative convergence. More...
 
virtual ADReal minimumPermissibleValue (const ADReal &) const override
 Compute the minimum permissible value of the scalar. More...
 
virtual ADReal maximumPermissibleValue (const ADReal &effective_trial_stress) const override
 Compute the maximum permissible value of the scalar. More...
 
virtual Real computeTimeStepLimit () override
 Compute the limiting value of the time step for this material. More...
 
bool requiresIsotropicTensor () override
 Does the model require the elasticity tensor to be isotropic? More...
 
void setQp (unsigned int qp)
 Sets the value of the global variable _qp for inheriting classes. More...
 
void resetQpProperties () final
 Retained as empty methods to avoid a warning from Material.C in framework. These methods are unused in all inheriting classes and should not be overwritten. More...
 
void resetProperties () final
 

Static Public Member Functions

static InputParameters validParams ()
 

Protected Member Functions

virtual ADReal computeResidual (const ADReal &effective_trial_stress, const ADReal &scalar) override
 Compute the residual for a predicted value of the scalar. More...
 
virtual ADReal computeDerivative (const ADReal &effective_trial_stress, const ADReal &scalar) override
 Compute the derivative of the residual as a function of the scalar variable. More...
 
virtual void computeStressInitialize (const ADReal &effective_trial_stress, const ADRankFourTensor &elasticity_tensor) override
 Perform any necessary initialization before return mapping iterations. More...
 
virtual void initQpStatefulProperties () override
 
virtual void propagateQpStatefulProperties () override
 If updateState is not called during a timestep, this will be. More...
 
virtual void computeStressFinalize (const ADRankTwoTensor &plastic_strain_increment) override
 Perform any necessary steps to finalize state after return mapping iterations. More...
 
 ADMaterialProperty (RankTwoTensor) &_creep_strain
 Creep strain material property. More...
 
 ADMaterialProperty (Real) &_effective_inelastic_strain
 
void propagateQpStatefulPropertiesRadialReturn ()
 Propagate the properties pertaining to this intermediate class. More...
 
void outputIterationSummary (std::stringstream *iter_output, const unsigned int total_it) override
 Output summary information for the convergence history of the model. More...
 
void returnMappingSolve (const ADReal &effective_trial_stress, ADReal &scalar, const ConsoleStream &console)
 Perform the return mapping iterations. More...
 
virtual ADReal initialGuess (const ADReal &)
 Compute an initial guess for the value of the scalar. More...
 
virtual void iterationFinalize (ADReal)
 Finalize internal state variables for a model for a given iteration. More...
 
virtual void outputIterationStep (std::stringstream *iter_output, const ADReal &effective_trial_stress, const ADReal &scalar, const Real reference_residual)
 Output information for a single iteration step to build the convergence history of the model. More...
 
bool converged (const ADReal &residual, const Real reference)
 Check to see whether the residual is within the convergence limits. More...
 

Protected Attributes

 usingRadialReturnCreepStressUpdateBaseMembers
 
const ADVariableValue * _temperature
 Temperature variable value. More...
 
const Real _coefficient
 Leading coefficient. More...
 
const Real _n_exponent
 Exponent on the effective stress. More...
 
const Real _m_exponent
 Exponent on time. More...
 
const Real _activation_energy
 Activation energy for exp term. More...
 
const Real _gas_constant
 Gas constant for exp term. More...
 
const Real _start_time
 Simulation start time. More...
 
ADReal _exponential
 Exponential calculated from activiaction, gas constant, and temperature. More...
 
Real _exp_time
 Exponential calculated from current time. More...
 
const MaterialProperty< RankTwoTensor > & _creep_strain_old
 
 usingRadialReturnStressUpdateMembers
 
ADReal _three_shear_modulus
 3 * shear modulus More...
 
const MaterialProperty< Real > & _effective_inelastic_strain_old
 
Real _max_inelastic_increment
 
const bool _apply_strain
 
 usingStressUpdateBaseMembers
 
 usingSingleVariableReturnMappingSolutionMembers
 
const std::string _base_name
 Name used as a prefix for all material properties related to the stress update model. More...
 
 usingMaterialMembers
 
bool _check_range
 Whether to check to see whether iterative solution is within admissible range, and set within that range if outside. More...
 
bool _line_search
 Whether to use line searches to improve convergence. More...
 
bool _bracket_solution
 Whether to save upper and lower bounds of root for scalar, and set solution to the midpoint between those bounds if outside them. More...
 

Private Types

enum  InternalSolveOutput { InternalSolveOutput::NEVER, InternalSolveOutput::ON_ERROR, InternalSolveOutput::ALWAYS }
 
enum  SolveState { SolveState::SUCCESS, SolveState::NAN_INF, SolveState::EXCEEDED_ITERATIONS }
 

Private Member Functions

SolveState internalSolve (const ADReal effective_trial_stress, ADReal &scalar, std::stringstream *iter_output=nullptr)
 Method called from within this class to perform the actual return mappping iterations. More...
 
bool convergedAcceptable (const unsigned int it, const Real reference)
 Check to see whether the residual is within acceptable convergence limits. More...
 
void checkPermissibleRange (ADReal &scalar, ADReal &scalar_increment, const ADReal &scalar_old, const ADReal min_permissible_scalar, const ADReal max_permissible_scalar, std::stringstream *iter_output)
 Check to see whether solution is within admissible range, and set it within that range if it is not. More...
 
void updateBounds (const ADReal &scalar, const ADReal &residual, const Real init_resid_sign, ADReal &scalar_upper_bound, ADReal &scalar_lower_bound, std::stringstream *iter_output)
 Update the upper and lower bounds of the root for the effective inelastic strain. More...
 

Private Attributes

enum ADSingleVariableReturnMappingSolution::InternalSolveOutput _internal_solve_output_on
 
const unsigned int _max_its
 Maximum number of return mapping iterations. More...
 
const bool _internal_solve_full_iteration_history
 Whether to output iteration information all the time (regardless of whether iterations converge) More...
 
Real _relative_tolerance
 Relative convergence tolerance. More...
 
Real _absolute_tolerance
 Absolute convergence tolerance. More...
 
Real _acceptable_multiplier
 Multiplier applied to relative and absolute tolerances for acceptable convergence. More...
 
const std::size_t _num_resids
 Number of residuals to be stored in history. More...
 
std::vector< Real > _residual_history
 History of residuals used to check whether progress is still being made on decreasing the residual. More...
 
unsigned int _iteration
 iteration number More...
 
const std::string _svrms_name
 MOOSE input name of the object performing the solve. More...
 
ADReal _initial_residual
 Residual values, kept as members to retain solver state for summary outputting. More...
 
ADReal _residual
 

Detailed Description

template<ComputeStage compute_stage>
class ADPowerLawCreepExceptionTest< compute_stage >

Definition at line 15 of file ADPowerLawCreepExceptionTest.h.

Member Enumeration Documentation

◆ InternalSolveOutput

template<ComputeStage compute_stage>
enum ADSingleVariableReturnMappingSolution::InternalSolveOutput
strongprivateinherited
Enumerator
NEVER 
ON_ERROR 
ALWAYS 

Definition at line 156 of file ADSingleVariableReturnMappingSolution.h.

157  {
158  NEVER,
159  ON_ERROR,
160  ALWAYS

◆ SolveState

template<ComputeStage compute_stage>
enum ADSingleVariableReturnMappingSolution::SolveState
strongprivateinherited
Enumerator
SUCCESS 
NAN_INF 
EXCEEDED_ITERATIONS 

Definition at line 163 of file ADSingleVariableReturnMappingSolution.h.

164  {
165  SUCCESS,
166  NAN_INF,
167  EXCEEDED_ITERATIONS
168  };

Constructor & Destructor Documentation

◆ ADPowerLawCreepExceptionTest()

template<ComputeStage compute_stage>
ADPowerLawCreepExceptionTest< compute_stage >::ADPowerLawCreepExceptionTest ( const InputParameters &  parameters)

Definition at line 30 of file ADPowerLawCreepExceptionTest.C.

33 {
34 }

Member Function Documentation

◆ ADMaterialProperty() [1/2]

template<ComputeStage compute_stage>
ADRadialReturnCreepStressUpdateBase< compute_stage >::ADMaterialProperty ( RankTwoTensor  ) &
protectedinherited

Creep strain material property.

◆ ADMaterialProperty() [2/2]

template<ComputeStage compute_stage>
ADRadialReturnStressUpdate< compute_stage >::ADMaterialProperty ( Real  ) &
protectedinherited

◆ checkPermissibleRange()

template<ComputeStage compute_stage>
void ADSingleVariableReturnMappingSolution< compute_stage >::checkPermissibleRange ( ADReal &  scalar,
ADReal &  scalar_increment,
const ADReal &  scalar_old,
const ADReal  min_permissible_scalar,
const ADReal  max_permissible_scalar,
std::stringstream *  iter_output 
)
privateinherited

Check to see whether solution is within admissible range, and set it within that range if it is not.

Parameters
scalarCurrent value of the inelastic strain increment
scalar_incrementIncremental change in scalar from the previous iteration
scalar_oldPrevious value of scalar
min_permissible_scalarMinimum permissible value of scalar
max_permissible_scalarMaximum permissible value of scalar
iter_outputOutput stream

Definition at line 334 of file ADSingleVariableReturnMappingSolution.C.

341 {
342  if (scalar > max_permissible_scalar)
343  {
344  scalar_increment = (max_permissible_scalar - scalar_old) / 2.0;
345  scalar = scalar_old + scalar_increment;
346  if (iter_output)
347  *iter_output << "Scalar greater than maximum ("
348  << MetaPhysicL::raw_value(max_permissible_scalar)
349  << ") adjusted scalar=" << MetaPhysicL::raw_value(scalar)
350  << " scalar_increment=" << MetaPhysicL::raw_value(scalar_increment) << std::endl;
351  }
352  else if (scalar < min_permissible_scalar)
353  {
354  scalar_increment = (min_permissible_scalar - scalar_old) / 2.0;
355  scalar = scalar_old + scalar_increment;
356  if (iter_output)
357  *iter_output << "Scalar less than minimum (" << MetaPhysicL::raw_value(min_permissible_scalar)
358  << ") adjusted scalar=" << MetaPhysicL::raw_value(scalar)
359  << " scalar_increment=" << MetaPhysicL::raw_value(scalar_increment) << std::endl;
360  }
361 }

◆ computeDerivative()

template<ComputeStage compute_stage>
ADReal ADPowerLawCreepExceptionTest< compute_stage >::computeDerivative ( const ADReal &  effective_trial_stress,
const ADReal &  scalar 
)
overrideprotectedvirtual

Compute the derivative of the residual as a function of the scalar variable.

The residual should be in strain increment units for all models for consistency.

Parameters
effective_trial_stressEffective trial stress
scalarInelastic strain increment magnitude being solved for

Reimplemented from ADPowerLawCreepStressUpdate< compute_stage >.

Definition at line 51 of file ADPowerLawCreepExceptionTest.C.

53 {
54  if (_fe_problem.getNonlinearSystemBase().getCurrentNonlinearIterationNumber() == 1 &&
55  _t_step == 1 && _dt > 0.9)
56  return 1.0;
57 
59  scalar);
60 }

◆ computeReferenceResidual()

template<ComputeStage compute_stage>
Real ADRadialReturnStressUpdate< compute_stage >::computeReferenceResidual ( const ADReal &  effective_trial_stress,
const ADReal &  scalar 
)
overridevirtualinherited

Compute a reference quantity to be used for checking relative convergence.

This should be in strain increment units for all models for consistency.

Parameters
effective_trial_stressEffective trial stress
scalarInelastic strain increment magnitude being solved for

Implements ADSingleVariableReturnMappingSolution< compute_stage >.

Definition at line 124 of file ADRadialReturnStressUpdate.C.

126 {
127  return MetaPhysicL::raw_value(effective_trial_stress / _three_shear_modulus) -
128  MetaPhysicL::raw_value(scalar_effective_inelastic_strain);
129 }

◆ computeResidual()

template<ComputeStage compute_stage>
ADReal ADPowerLawCreepExceptionTest< compute_stage >::computeResidual ( const ADReal &  effective_trial_stress,
const ADReal &  scalar 
)
overrideprotectedvirtual

Compute the residual for a predicted value of the scalar.

This residual should be in strain increment units for all models for consistency.

Parameters
effective_trial_stressEffective trial stress
scalarInelastic strain increment magnitude being solved for

Reimplemented from ADPowerLawCreepStressUpdate< compute_stage >.

Definition at line 38 of file ADPowerLawCreepExceptionTest.C.

40 {
41  if (_fe_problem.getNonlinearSystemBase().getCurrentNonlinearIterationNumber() == 1 &&
42  _t_step == 1 && _dt > 0.9)
43  return 1.0;
44 
46  scalar);
47 }

◆ computeStressFinalize()

template<ComputeStage compute_stage>
void ADRadialReturnCreepStressUpdateBase< compute_stage >::computeStressFinalize ( const ADRankTwoTensor &  )
overrideprotectedvirtualinherited

Perform any necessary steps to finalize state after return mapping iterations.

Parameters
inelasticStrainIncrementInelastic strain increment

Reimplemented from ADRadialReturnStressUpdate< compute_stage >.

Reimplemented in ADLAROMANCEStressUpdateBase< compute_stage >.

Definition at line 53 of file ADRadialReturnCreepStressUpdateBase.C.

55 {
56  _creep_strain[_qp] = _creep_strain_old[_qp] + plastic_strain_increment;
57 }

Referenced by ADLAROMANCEStressUpdateBase< compute_stage >::computeStressFinalize().

◆ computeStressInitialize()

template<ComputeStage compute_stage>
void ADPowerLawCreepStressUpdate< compute_stage >::computeStressInitialize ( const ADReal &  ,
const ADRankFourTensor &   
)
overrideprotectedvirtualinherited

Perform any necessary initialization before return mapping iterations.

Parameters
effective_trial_stressEffective trial stress
elasticityTensorElasticity tensor

Reimplemented from ADRadialReturnStressUpdate< compute_stage >.

Definition at line 58 of file ADPowerLawCreepStressUpdate.C.

60 {
61  if (_temperature)
62  _exponential = std::exp(-_activation_energy / (_gas_constant * (*_temperature)[_qp]));
63 
65 }

◆ computeTimeStepLimit()

template<ComputeStage compute_stage>
Real ADRadialReturnStressUpdate< compute_stage >::computeTimeStepLimit ( )
overridevirtualinherited

Compute the limiting value of the time step for this material.

Returns
Limiting time step

Reimplemented from ADStressUpdateBase< compute_stage >.

Reimplemented in ADLAROMANCEStressUpdateBase< compute_stage >.

Definition at line 141 of file ADRadialReturnStressUpdate.C.

142 {
143  Real scalar_inelastic_strain_incr = MetaPhysicL::raw_value(_effective_inelastic_strain[_qp]) -
145  if (MooseUtils::absoluteFuzzyEqual(scalar_inelastic_strain_incr, 0.0))
146  return std::numeric_limits<Real>::max();
147 
148  return _dt * _max_inelastic_increment / scalar_inelastic_strain_incr;
149 }

Referenced by ADLAROMANCEStressUpdateBase< compute_stage >::computeTimeStepLimit().

◆ converged()

template<ComputeStage compute_stage>
bool ADSingleVariableReturnMappingSolution< compute_stage >::converged ( const ADReal &  residual,
const Real  reference 
)
protectedinherited

Check to see whether the residual is within the convergence limits.

Parameters
residualCurrent value of the residual
referenceCurrent value of the reference quantity
Returns
Whether the model converged

Definition at line 301 of file ADSingleVariableReturnMappingSolution.C.

303 {
304  const Real residual = MetaPhysicL::raw_value(ad_residual);
305  return (std::abs(residual) <= _absolute_tolerance ||
306  std::abs(residual / reference) <= _relative_tolerance);
307 }

◆ convergedAcceptable()

template<ComputeStage compute_stage>
bool ADSingleVariableReturnMappingSolution< compute_stage >::convergedAcceptable ( const unsigned int  it,
const Real  reference 
)
privateinherited

Check to see whether the residual is within acceptable convergence limits.

This will only return true if it has been determined that progress is no longer being made and that the residual is within the acceptable limits.

Parameters
residualCurrent iteration count
residualCurrent value of the residual
referenceCurrent value of the reference quantity
Returns
Whether the model converged

Definition at line 311 of file ADSingleVariableReturnMappingSolution.C.

313 {
314  // Require that we have at least done _num_resids evaluations before we allow for
315  // acceptable convergence
316  if (it < _num_resids)
317  return false;
318 
319  // Check to see whether the residual has dropped by convergence_history_factor over
320  // the last _num_resids iterations. If it has (which means it's still making progress),
321  // don't consider it to be converged within the acceptable limits.
322  const Real convergence_history_factor = 10.0;
323  if (std::abs(_residual * convergence_history_factor) <
324  std::abs(_residual_history[(it + 1) % _num_resids]))
325  return false;
326 
327  // Now that it's determined that progress is not being made, treat it as converged if
328  // we're within the acceptable convergence limits
329  return converged(_residual / _acceptable_multiplier, reference);
330 }

◆ initialGuess()

template<ComputeStage compute_stage>
virtual ADReal ADSingleVariableReturnMappingSolution< compute_stage >::initialGuess ( const ADReal &  )
inlineprotectedvirtualinherited

Compute an initial guess for the value of the scalar.

For some cases, an intellegent starting point can provide enhanced robustness in the Newton iterations. This is also an opportunity for classes that derive from this to perform initialization tasks.

Parameters
effective_trial_stressEffective trial stress

Reimplemented in ADViscoplasticityStressUpdate< compute_stage >.

Definition at line 82 of file ADSingleVariableReturnMappingSolution.h.

82 { return 0.0; }

◆ initQpStatefulProperties()

template<ComputeStage compute_stage>
void ADRadialReturnCreepStressUpdateBase< compute_stage >::initQpStatefulProperties ( )
overrideprotectedvirtualinherited

◆ internalSolve()

template<ComputeStage compute_stage>
ADSingleVariableReturnMappingSolution< compute_stage >::SolveState ADSingleVariableReturnMappingSolution< compute_stage >::internalSolve ( const ADReal  effective_trial_stress,
ADReal &  scalar,
std::stringstream *  iter_output = nullptr 
)
privateinherited

Method called from within this class to perform the actual return mappping iterations.

Parameters
effective_trial_stressEffective trial stress
scalarInelastic strain increment magnitude being solved for
iter_outputOutput stream – if null, no output is produced
Returns
Whether the solution was successful

Definition at line 162 of file ADSingleVariableReturnMappingSolution.C.

164 {
165  scalar = initialGuess(effective_trial_stress);
166  ADReal scalar_old = scalar;
167  ADReal scalar_increment = 0.0;
168  const ADReal min_permissible_scalar = minimumPermissibleValue(effective_trial_stress);
169  const ADReal max_permissible_scalar = maximumPermissibleValue(effective_trial_stress);
170  ADReal scalar_upper_bound = max_permissible_scalar;
171  ADReal scalar_lower_bound = min_permissible_scalar;
172  _iteration = 0;
173 
174  _initial_residual = _residual = computeResidual(effective_trial_stress, scalar);
175 
176  ADReal residual_old = _residual;
177  Real init_resid_sign = MathUtils::sign(MetaPhysicL::raw_value(_residual));
178  Real reference_residual = computeReferenceResidual(effective_trial_stress, scalar);
179 
180  if (converged(_residual, reference_residual))
181  {
182  iterationFinalize(scalar);
183  outputIterationStep(iter_output, effective_trial_stress, scalar, reference_residual);
184  return SolveState::SUCCESS;
185  }
186 
187  _residual_history.assign(_num_resids, std::numeric_limits<Real>::max());
188  _residual_history[0] = MetaPhysicL::raw_value(_residual);
189 
190  while (_iteration < _max_its && !converged(_residual, reference_residual) &&
191  !convergedAcceptable(_iteration, reference_residual))
192  {
193  scalar_increment = -_residual / computeDerivative(effective_trial_stress, scalar);
194  scalar = scalar_old + scalar_increment;
195 
196  if (_check_range)
197  checkPermissibleRange(scalar,
198  scalar_increment,
199  scalar_old,
200  min_permissible_scalar,
201  max_permissible_scalar,
202  iter_output);
203 
204  _residual = computeResidual(effective_trial_stress, scalar);
205  reference_residual = computeReferenceResidual(effective_trial_stress, scalar);
206  iterationFinalize(scalar);
207 
208  if (_bracket_solution)
209  updateBounds(
210  scalar, _residual, init_resid_sign, scalar_upper_bound, scalar_lower_bound, iter_output);
211 
212  if (converged(_residual, reference_residual))
213  {
214  outputIterationStep(iter_output, effective_trial_stress, scalar, reference_residual);
215  break;
216  }
217  else
218  {
219  bool modified_increment = false;
220 
221  // Line Search
222  if (_line_search)
223  {
224  if (residual_old - _residual != 0.0)
225  {
226  ADReal alpha = residual_old / (residual_old - _residual);
227  alpha = MathUtils::clamp(alpha, 1.0e-2, 1.0);
228 
229  if (alpha != 1.0)
230  {
231  modified_increment = true;
232  scalar_increment *= alpha;
233  if (iter_output)
234  *iter_output << " Line search alpha = " << MetaPhysicL::raw_value(alpha)
235  << " increment = " << MetaPhysicL::raw_value(scalar_increment)
236  << std::endl;
237  }
238  }
239  }
240 
241  if (_bracket_solution)
242  {
243  // Check to see whether trial scalar_increment is outside the bounds, and set it to a point
244  // within the bounds if it is
245  if (scalar_old + scalar_increment >= scalar_upper_bound ||
246  scalar_old + scalar_increment <= scalar_lower_bound)
247  {
248  if (scalar_upper_bound != max_permissible_scalar &&
249  scalar_lower_bound != min_permissible_scalar)
250  {
251  const Real frac = 0.5;
252  scalar_increment =
253  (1.0 - frac) * scalar_lower_bound + frac * scalar_upper_bound - scalar_old;
254  modified_increment = true;
255  if (iter_output)
256  *iter_output << " Trial scalar_increment exceeded bounds. Setting between "
257  "lower/upper bounds. frac: "
258  << frac << std::endl;
259  }
260  }
261  }
262 
263  // Update the trial scalar and recompute residual if the line search or bounds checking
264  // modified the increment
265  if (modified_increment)
266  {
267  scalar = scalar_old + scalar_increment;
268  _residual = computeResidual(effective_trial_stress, scalar);
269  reference_residual = computeReferenceResidual(effective_trial_stress, scalar);
270  iterationFinalize(scalar);
271 
272  if (_bracket_solution)
273  updateBounds(scalar,
274  _residual,
275  init_resid_sign,
276  scalar_upper_bound,
277  scalar_lower_bound,
278  iter_output);
279  }
280  }
281 
282  outputIterationStep(iter_output, effective_trial_stress, scalar, reference_residual);
283 
284  ++_iteration;
285  residual_old = _residual;
286  scalar_old = scalar;
287  _residual_history[_iteration % _num_resids] = MetaPhysicL::raw_value(_residual);
288  }
289 
290  if (std::isnan(_residual) || std::isinf(MetaPhysicL::raw_value(_residual)))
291  return SolveState::NAN_INF;
292 
293  if (_iteration == _max_its)
295 
296  return SolveState::SUCCESS;
297 }

◆ iterationFinalize()

template<ComputeStage compute_stage>
virtual void ADSingleVariableReturnMappingSolution< compute_stage >::iterationFinalize ( ADReal  )
inlineprotectedvirtualinherited

Finalize internal state variables for a model for a given iteration.

Parameters
scalarInelastic strain increment magnitude being solved for

Reimplemented in ADIsotropicPlasticityStressUpdate< compute_stage >.

Definition at line 114 of file ADSingleVariableReturnMappingSolution.h.

114 {}

◆ maximumPermissibleValue()

template<ComputeStage compute_stage>
ADReal ADRadialReturnStressUpdate< compute_stage >::maximumPermissibleValue ( const ADReal &  effective_trial_stress) const
overridevirtualinherited

Compute the maximum permissible value of the scalar.

For some models, the magnitude of this may be known.

Parameters
effective_trial_stressEffective trial stress

Reimplemented from ADSingleVariableReturnMappingSolution< compute_stage >.

Definition at line 133 of file ADRadialReturnStressUpdate.C.

135 {
136  return effective_trial_stress / _three_shear_modulus;
137 }

◆ minimumPermissibleValue()

template<ComputeStage compute_stage>
virtual ADReal ADRadialReturnStressUpdate< compute_stage >::minimumPermissibleValue ( const ADReal &  effective_trial_stress) const
inlineoverridevirtualinherited

Compute the minimum permissible value of the scalar.

For some models, the magnitude of this may be known.

Parameters
effective_trial_stressEffective trial stress

Reimplemented from ADSingleVariableReturnMappingSolution< compute_stage >.

Definition at line 73 of file ADRadialReturnStressUpdate.h.

74  {
75  return 0.0;
76  }

◆ outputIterationStep()

template<ComputeStage compute_stage>
void ADSingleVariableReturnMappingSolution< compute_stage >::outputIterationStep ( std::stringstream *  iter_output,
const ADReal &  effective_trial_stress,
const ADReal &  scalar,
const Real  reference_residual 
)
protectedvirtualinherited

Output information for a single iteration step to build the convergence history of the model.

Parameters
iter_outputOutput stream
itCurrent iteration count
effective_trial_stressEffective trial stress
scalarInelastic strain increment magnitude being solved for
residualCurrent value of the residual
referenceCurrent value of the reference quantity

Definition at line 393 of file ADSingleVariableReturnMappingSolution.C.

398 {
399  if (iter_output)
400  {
401  const unsigned int it = _iteration;
402  const Real residual = MetaPhysicL::raw_value(_residual);
403 
404  *iter_output << " iteration=" << it
405  << " trial_stress=" << MetaPhysicL::raw_value(effective_trial_stress)
406  << " scalar=" << MetaPhysicL::raw_value(scalar) << " residual=" << residual
407  << " ref_res=" << reference_residual
408  << " rel_res=" << std::abs(residual) / reference_residual
409  << " rel_tol=" << _relative_tolerance << " abs_res=" << std::abs(residual)
410  << " abs_tol=" << _absolute_tolerance << '\n';
411  }
412 }

◆ outputIterationSummary()

template<ComputeStage compute_stage>
void ADRadialReturnStressUpdate< compute_stage >::outputIterationSummary ( std::stringstream *  iter_output,
const unsigned int  total_it 
)
overrideprotectedvirtualinherited

Output summary information for the convergence history of the model.

Parameters
iter_outputOutput stream
total_itTotal iteration count

Reimplemented from ADSingleVariableReturnMappingSolution< compute_stage >.

Definition at line 153 of file ADRadialReturnStressUpdate.C.

155 {
156  if (iter_output)
157  {
158  *iter_output << "At element " << _current_elem->id() << " _qp=" << _qp << " Coordinates "
159  << _q_point[_qp] << " block=" << _current_elem->subdomain_id() << '\n';
160  }
162  total_it);
163 }

◆ propagateQpStatefulProperties()

template<ComputeStage compute_stage>
void ADRadialReturnCreepStressUpdateBase< compute_stage >::propagateQpStatefulProperties ( )
overrideprotectedvirtualinherited

If updateState is not called during a timestep, this will be.

This method allows derived classes to set internal parameters from their Old values, for instance

Reimplemented from ADStressUpdateBase< compute_stage >.

Definition at line 44 of file ADRadialReturnCreepStressUpdateBase.C.

45 {
46  _creep_strain[_qp] = _creep_strain_old[_qp];
47 
49 }

◆ propagateQpStatefulPropertiesRadialReturn()

template<ComputeStage compute_stage>
void ADRadialReturnStressUpdate< compute_stage >::propagateQpStatefulPropertiesRadialReturn ( )
protectedinherited

Propagate the properties pertaining to this intermediate class.

This is intended to be called from propagateQpStatefulProperties() in classes that inherit from this one. This is intentionally named uniquely because almost all models that derive from this class have their own stateful properties, and this forces them to define their own implementations of propagateQpStatefulProperties().

Definition at line 61 of file ADRadialReturnStressUpdate.C.

62 {
63  _effective_inelastic_strain[_qp] = _effective_inelastic_strain_old[_qp];
64 }

◆ requiresIsotropicTensor()

template<ComputeStage compute_stage>
bool ADRadialReturnStressUpdate< compute_stage >::requiresIsotropicTensor ( )
inlineoverridevirtualinherited

Does the model require the elasticity tensor to be isotropic?

Implements ADStressUpdateBase< compute_stage >.

Definition at line 89 of file ADRadialReturnStressUpdate.h.

89 { return true; }

◆ resetProperties()

template<ComputeStage compute_stage>
void ADStressUpdateBase< compute_stage >::resetProperties ( )
inlinefinalinherited

Definition at line 104 of file ADStressUpdateBase.h.

104 {}

◆ resetQpProperties()

template<ComputeStage compute_stage>
void ADStressUpdateBase< compute_stage >::resetQpProperties ( )
inlinefinalinherited

Retained as empty methods to avoid a warning from Material.C in framework. These methods are unused in all inheriting classes and should not be overwritten.

Definition at line 103 of file ADStressUpdateBase.h.

103 {}

◆ returnMappingSolve()

template<ComputeStage compute_stage>
void ADSingleVariableReturnMappingSolution< compute_stage >::returnMappingSolve ( const ADReal &  effective_trial_stress,
ADReal &  scalar,
const ConsoleStream &  console 
)
protectedinherited

Perform the return mapping iterations.

Parameters
effective_trial_stressEffective trial stress
scalarInelastic strain increment magnitude being solved for
consoleConsole output

Definition at line 101 of file ADSingleVariableReturnMappingSolution.C.

103 {
104  // construct the stringstream here only if the debug level is set to ALL
105  std::unique_ptr<std::stringstream> iter_output =
107  ? libmesh_make_unique<std::stringstream>()
108  : nullptr;
109 
110  // do the internal solve and capture iteration info during the first round
111  // iff full history output is requested regardless of whether the solve failed or succeeded
112  auto solve_state =
113  internalSolve(effective_trial_stress,
114  scalar,
115  _internal_solve_full_iteration_history ? iter_output.get() : nullptr);
116  if (solve_state != SolveState::SUCCESS &&
118  {
119  // output suppressed by user, throw immediately
121  throw MooseException("");
122 
123  // user expects some kind of output, if necessary setup output stream now
124  if (!iter_output)
125  iter_output = libmesh_make_unique<std::stringstream>();
126 
127  // add the appropriate error message to the output
128  switch (solve_state)
129  {
130  case SolveState::NAN_INF:
131  *iter_output << "Encountered inf or nan in material return mapping iterations.\n";
132  break;
133 
135  *iter_output << "Exceeded maximum iterations in material return mapping iterations.\n";
136  break;
137 
138  default:
139  mooseError("Unhandled solver state");
140  }
141 
142  // if full history output is only requested for failed solves we have to repeat
143  // the solve a second time
145  internalSolve(effective_trial_stress, scalar, iter_output.get());
146 
147  // Append summary and throw exception
148  outputIterationSummary(iter_output.get(), _iteration);
149  throw MooseException(iter_output->str());
150  }
151 
153  {
154  // the solve did not fail but the user requested debug output anyways
155  outputIterationSummary(iter_output.get(), _iteration);
156  console << iter_output->str();
157  }
158 }

◆ setQp()

template<ComputeStage compute_stage>
void ADStressUpdateBase< compute_stage >::setQp ( unsigned int  qp)
inherited

Sets the value of the global variable _qp for inheriting classes.

Definition at line 47 of file ADStressUpdateBase.C.

48 {
49  _qp = qp;
50 }

◆ updateBounds()

template<ComputeStage compute_stage>
void ADSingleVariableReturnMappingSolution< compute_stage >::updateBounds ( const ADReal &  scalar,
const ADReal &  residual,
const Real  init_resid_sign,
ADReal &  scalar_upper_bound,
ADReal &  scalar_lower_bound,
std::stringstream *  iter_output 
)
privateinherited

Update the upper and lower bounds of the root for the effective inelastic strain.

Parameters
scalarCurrent value of the inelastic strain increment
residualCurrent value of the residual
init_resid_signSign of the initial value of the residual
scalar_upper_boundUpper bound value of scalar
scalar_lower_boundLower bound value of scalar
iter_outputOutput stream

Definition at line 365 of file ADSingleVariableReturnMappingSolution.C.

371 {
372  // Update upper/lower bounds as applicable
373  if (residual * init_resid_sign < 0.0 && scalar < scalar_upper_bound)
374  {
375  scalar_upper_bound = scalar;
376  if (scalar_upper_bound < scalar_lower_bound)
377  {
378  scalar_upper_bound = scalar_lower_bound;
379  scalar_lower_bound = 0.0;
380  if (iter_output)
381  *iter_output << " Corrected for scalar_upper_bound < scalar_lower_bound" << std::endl;
382  }
383  }
384  // Don't permit setting scalar_lower_bound > scalar_upper_bound (but do permit the reverse).
385  // This ensures that if we encounter multiple roots, we pick the lowest one.
386  else if (residual * init_resid_sign > 0.0 && scalar > scalar_lower_bound &&
387  scalar < scalar_upper_bound)
388  scalar_lower_bound = scalar;
389 }

◆ updateState()

template<ComputeStage compute_stage>
void ADRadialReturnStressUpdate< compute_stage >::updateState ( ADRankTwoTensor &  strain_increment,
ADRankTwoTensor &  inelastic_strain_increment,
const ADRankTwoTensor &  rotation_increment,
ADRankTwoTensor &  stress_new,
const RankTwoTensor stress_old,
const ADRankFourTensor &  elasticity_tensor,
const RankTwoTensor elastic_strain_old 
)
overridevirtualinherited

A radial return (J2) mapping method is performed with return mapping iterations.

Parameters
strain_incrementSum of elastic and inelastic strain increments
inelastic_strain_incrementInelastic strain increment calculated by this class
rotationincrement Not used by this class
stress_newNew trial stress from pure elastic calculation
stress_oldOld state of stress
elasticity_tensorRank 4 C_{ijkl}, must be isotropic
elastic_strain_oldOld state of total elastic strain

Implements ADStressUpdateBase< compute_stage >.

Definition at line 68 of file ADRadialReturnStressUpdate.C.

76 {
77  // compute the deviatoric trial stress and trial strain from the current intermediate
78  // configuration
79  ADRankTwoTensor deviatoric_trial_stress = stress_new.deviatoric();
80 
81  // compute the effective trial stress
82  ADReal dev_trial_stress_squared =
83  deviatoric_trial_stress.doubleContraction(deviatoric_trial_stress);
84  ADReal effective_trial_stress =
85  dev_trial_stress_squared == 0.0 ? 0.0 : std::sqrt(3.0 / 2.0 * dev_trial_stress_squared);
86 
87  // Set the value of 3 * shear modulus for use as a reference residual value
89 
90  computeStressInitialize(effective_trial_stress, elasticity_tensor);
91 
92  // Use Newton iteration to determine the scalar effective inelastic strain increment
93  ADReal scalar_effective_inelastic_strain = 0.0;
94  if (!MooseUtils::absoluteFuzzyEqual(effective_trial_stress, 0.0))
95  {
96  returnMappingSolve(effective_trial_stress, scalar_effective_inelastic_strain, _console);
97  if (scalar_effective_inelastic_strain != 0.0)
98  inelastic_strain_increment =
99  deviatoric_trial_stress *
100  (1.5 * scalar_effective_inelastic_strain / effective_trial_stress);
101  else
102  inelastic_strain_increment.zero();
103  }
104  else
105  inelastic_strain_increment.zero();
106 
107  if (_apply_strain)
108  {
109  strain_increment -= inelastic_strain_increment;
110  _effective_inelastic_strain[_qp] =
111  _effective_inelastic_strain_old[_qp] + scalar_effective_inelastic_strain;
112 
113  // Use the old elastic strain here because we require tensors used by this class
114  // to be isotropic and this method natively allows for changing in time
115  // elasticity tensors
116  stress_new = elasticity_tensor * (elastic_strain_old + strain_increment);
117  }
118 
119  computeStressFinalize(inelastic_strain_increment);
120 }

◆ validParams()

template<ComputeStage compute_stage>
InputParameters ADPowerLawCreepExceptionTest< compute_stage >::validParams ( )
static

Definition at line 20 of file ADPowerLawCreepExceptionTest.C.

21 {
23  params.addClassDescription(
24  "This class duplicates the ADPowerLawCreepStressUpdate, except at the 2nd time step and the "
25  "1st iteration, at which time a high residual is computed, forcing an exception.");
26  return params;
27 }

Member Data Documentation

◆ _absolute_tolerance

template<ComputeStage compute_stage>
Real ADSingleVariableReturnMappingSolution< compute_stage >::_absolute_tolerance
privateinherited

Absolute convergence tolerance.

Definition at line 181 of file ADSingleVariableReturnMappingSolution.h.

◆ _acceptable_multiplier

template<ComputeStage compute_stage>
Real ADSingleVariableReturnMappingSolution< compute_stage >::_acceptable_multiplier
privateinherited

Multiplier applied to relative and absolute tolerances for acceptable convergence.

Definition at line 184 of file ADSingleVariableReturnMappingSolution.h.

◆ _activation_energy

template<ComputeStage compute_stage>
const Real ADPowerLawCreepStressUpdate< compute_stage >::_activation_energy
protectedinherited

Activation energy for exp term.

Definition at line 58 of file ADPowerLawCreepStressUpdate.h.

◆ _apply_strain

template<ComputeStage compute_stage>
const bool ADRadialReturnStressUpdate< compute_stage >::_apply_strain
protectedinherited

Definition at line 129 of file ADRadialReturnStressUpdate.h.

◆ _base_name

template<ComputeStage compute_stage>
const std::string ADStressUpdateBase< compute_stage >::_base_name
protectedinherited

Name used as a prefix for all material properties related to the stress update model.

Definition at line 109 of file ADStressUpdateBase.h.

◆ _bracket_solution

template<ComputeStage compute_stage>
bool ADSingleVariableReturnMappingSolution< compute_stage >::_bracket_solution
protectedinherited

Whether to save upper and lower bounds of root for scalar, and set solution to the midpoint between those bounds if outside them.

Definition at line 131 of file ADSingleVariableReturnMappingSolution.h.

◆ _check_range

template<ComputeStage compute_stage>
bool ADSingleVariableReturnMappingSolution< compute_stage >::_check_range
protectedinherited

Whether to check to see whether iterative solution is within admissible range, and set within that range if outside.

Definition at line 124 of file ADSingleVariableReturnMappingSolution.h.

Referenced by ADViscoplasticityStressUpdate< compute_stage >::ADViscoplasticityStressUpdate().

◆ _coefficient

template<ComputeStage compute_stage>
const Real ADPowerLawCreepStressUpdate< compute_stage >::_coefficient
protectedinherited

Leading coefficient.

Definition at line 49 of file ADPowerLawCreepStressUpdate.h.

◆ _creep_strain_old

template<ComputeStage compute_stage>
const MaterialProperty<RankTwoTensor>& ADRadialReturnCreepStressUpdateBase< compute_stage >::_creep_strain_old
protectedinherited

Definition at line 44 of file ADRadialReturnCreepStressUpdateBase.h.

◆ _effective_inelastic_strain_old

template<ComputeStage compute_stage>
const MaterialProperty<Real>& ADRadialReturnStressUpdate< compute_stage >::_effective_inelastic_strain_old
protectedinherited

Definition at line 127 of file ADRadialReturnStressUpdate.h.

◆ _exp_time

template<ComputeStage compute_stage>
Real ADPowerLawCreepStressUpdate< compute_stage >::_exp_time
protectedinherited

Exponential calculated from current time.

Definition at line 70 of file ADPowerLawCreepStressUpdate.h.

◆ _exponential

template<ComputeStage compute_stage>
ADReal ADPowerLawCreepStressUpdate< compute_stage >::_exponential
protectedinherited

Exponential calculated from activiaction, gas constant, and temperature.

Definition at line 67 of file ADPowerLawCreepStressUpdate.h.

◆ _gas_constant

template<ComputeStage compute_stage>
const Real ADPowerLawCreepStressUpdate< compute_stage >::_gas_constant
protectedinherited

Gas constant for exp term.

Definition at line 61 of file ADPowerLawCreepStressUpdate.h.

◆ _initial_residual

template<ComputeStage compute_stage>
ADReal ADSingleVariableReturnMappingSolution< compute_stage >::_initial_residual
privateinherited

Residual values, kept as members to retain solver state for summary outputting.

Definition at line 196 of file ADSingleVariableReturnMappingSolution.h.

◆ _internal_solve_full_iteration_history

template<ComputeStage compute_stage>
const bool ADSingleVariableReturnMappingSolution< compute_stage >::_internal_solve_full_iteration_history
privateinherited

Whether to output iteration information all the time (regardless of whether iterations converge)

Definition at line 175 of file ADSingleVariableReturnMappingSolution.h.

◆ _internal_solve_output_on

template<ComputeStage compute_stage>
enum ADSingleVariableReturnMappingSolution::InternalSolveOutput ADSingleVariableReturnMappingSolution< compute_stage >::_internal_solve_output_on
privateinherited

◆ _iteration

template<ComputeStage compute_stage>
unsigned int ADSingleVariableReturnMappingSolution< compute_stage >::_iteration
privateinherited

iteration number

Definition at line 193 of file ADSingleVariableReturnMappingSolution.h.

◆ _line_search

template<ComputeStage compute_stage>
bool ADSingleVariableReturnMappingSolution< compute_stage >::_line_search
protectedinherited

Whether to use line searches to improve convergence.

Definition at line 127 of file ADSingleVariableReturnMappingSolution.h.

◆ _m_exponent

template<ComputeStage compute_stage>
const Real ADPowerLawCreepStressUpdate< compute_stage >::_m_exponent
protectedinherited

◆ _max_inelastic_increment

template<ComputeStage compute_stage>
Real ADRadialReturnStressUpdate< compute_stage >::_max_inelastic_increment
protectedinherited

Definition at line 128 of file ADRadialReturnStressUpdate.h.

◆ _max_its

template<ComputeStage compute_stage>
const unsigned int ADSingleVariableReturnMappingSolution< compute_stage >::_max_its
privateinherited

Maximum number of return mapping iterations.

This exists only to avoid an infinite loop, and is is intended to be a large number that is not settable by the user.

Definition at line 172 of file ADSingleVariableReturnMappingSolution.h.

◆ _n_exponent

template<ComputeStage compute_stage>
const Real ADPowerLawCreepStressUpdate< compute_stage >::_n_exponent
protectedinherited

Exponent on the effective stress.

Definition at line 52 of file ADPowerLawCreepStressUpdate.h.

◆ _num_resids

template<ComputeStage compute_stage>
const std::size_t ADSingleVariableReturnMappingSolution< compute_stage >::_num_resids
privateinherited

Number of residuals to be stored in history.

Definition at line 187 of file ADSingleVariableReturnMappingSolution.h.

◆ _relative_tolerance

template<ComputeStage compute_stage>
Real ADSingleVariableReturnMappingSolution< compute_stage >::_relative_tolerance
privateinherited

Relative convergence tolerance.

Definition at line 178 of file ADSingleVariableReturnMappingSolution.h.

◆ _residual

template<ComputeStage compute_stage>
ADReal ADSingleVariableReturnMappingSolution< compute_stage >::_residual
privateinherited

Definition at line 197 of file ADSingleVariableReturnMappingSolution.h.

◆ _residual_history

template<ComputeStage compute_stage>
std::vector<Real> ADSingleVariableReturnMappingSolution< compute_stage >::_residual_history
privateinherited

History of residuals used to check whether progress is still being made on decreasing the residual.

Definition at line 190 of file ADSingleVariableReturnMappingSolution.h.

◆ _start_time

template<ComputeStage compute_stage>
const Real ADPowerLawCreepStressUpdate< compute_stage >::_start_time
protectedinherited

Simulation start time.

Definition at line 64 of file ADPowerLawCreepStressUpdate.h.

◆ _svrms_name

template<ComputeStage compute_stage>
const std::string ADSingleVariableReturnMappingSolution< compute_stage >::_svrms_name
privateinherited

MOOSE input name of the object performing the solve.

Definition at line 201 of file ADSingleVariableReturnMappingSolution.h.

◆ _temperature

template<ComputeStage compute_stage>
const ADVariableValue* ADPowerLawCreepStressUpdate< compute_stage >::_temperature
protectedinherited

Temperature variable value.

Definition at line 46 of file ADPowerLawCreepStressUpdate.h.

◆ _three_shear_modulus

template<ComputeStage compute_stage>
ADReal ADRadialReturnStressUpdate< compute_stage >::_three_shear_modulus
protectedinherited

3 * shear modulus

Definition at line 124 of file ADRadialReturnStressUpdate.h.

◆ usingMaterialMembers

template<ComputeStage compute_stage>
ADStressUpdateBase< compute_stage >::usingMaterialMembers
protectedinherited

Definition at line 111 of file ADStressUpdateBase.h.

◆ usingRadialReturnCreepStressUpdateBaseMembers

template<ComputeStage compute_stage>
ADPowerLawCreepExceptionTest< compute_stage >::usingRadialReturnCreepStressUpdateBaseMembers
protected

Definition at line 33 of file ADPowerLawCreepExceptionTest.h.

◆ usingRadialReturnStressUpdateMembers

template<ComputeStage compute_stage>
ADRadialReturnCreepStressUpdateBase< compute_stage >::usingRadialReturnStressUpdateMembers
protectedinherited

Definition at line 46 of file ADRadialReturnCreepStressUpdateBase.h.

◆ usingSingleVariableReturnMappingSolutionMembers

template<ComputeStage compute_stage>
ADRadialReturnStressUpdate< compute_stage >::usingSingleVariableReturnMappingSolutionMembers
protectedinherited

Definition at line 132 of file ADRadialReturnStressUpdate.h.

◆ usingStressUpdateBaseMembers

template<ComputeStage compute_stage>
ADRadialReturnStressUpdate< compute_stage >::usingStressUpdateBaseMembers
protectedinherited

Definition at line 131 of file ADRadialReturnStressUpdate.h.


The documentation for this class was generated from the following files:
ADRadialReturnStressUpdate::_effective_inelastic_strain_old
const MaterialProperty< Real > & _effective_inelastic_strain_old
Definition: ADRadialReturnStressUpdate.h:127
ADPowerLawCreepStressUpdate::_m_exponent
const Real _m_exponent
Exponent on time.
Definition: ADPowerLawCreepStressUpdate.h:55
ADSingleVariableReturnMappingSolution::initialGuess
virtual ADReal initialGuess(const ADReal &)
Compute an initial guess for the value of the scalar.
Definition: ADSingleVariableReturnMappingSolution.h:82
ADSingleVariableReturnMappingSolution::InternalSolveOutput::NEVER
ADSingleVariableReturnMappingSolution::_internal_solve_full_iteration_history
const bool _internal_solve_full_iteration_history
Whether to output iteration information all the time (regardless of whether iterations converge)
Definition: ADSingleVariableReturnMappingSolution.h:175
ADSingleVariableReturnMappingSolution::returnMappingSolve
void returnMappingSolve(const ADReal &effective_trial_stress, ADReal &scalar, const ConsoleStream &console)
Perform the return mapping iterations.
Definition: ADSingleVariableReturnMappingSolution.C:101
ADRadialReturnStressUpdate::_apply_strain
const bool _apply_strain
Definition: ADRadialReturnStressUpdate.h:129
ADSingleVariableReturnMappingSolution::SolveState::EXCEEDED_ITERATIONS
ADRadialReturnStressUpdate::computeStressInitialize
virtual void computeStressInitialize(const ADReal &, const ADRankFourTensor &)
Perform any necessary initialization before return mapping iterations.
Definition: ADRadialReturnStressUpdate.h:109
ADSingleVariableReturnMappingSolution::SolveState::NAN_INF
pow
ExpressionBuilder::EBTerm pow(const ExpressionBuilder::EBTerm &left, T exponent)
Definition: ExpressionBuilder.h:673
ADSingleVariableReturnMappingSolution::_bracket_solution
bool _bracket_solution
Whether to save upper and lower bounds of root for scalar, and set solution to the midpoint between t...
Definition: ADSingleVariableReturnMappingSolution.h:131
ADSingleVariableReturnMappingSolution::outputIterationStep
virtual void outputIterationStep(std::stringstream *iter_output, const ADReal &effective_trial_stress, const ADReal &scalar, const Real reference_residual)
Output information for a single iteration step to build the convergence history of the model.
Definition: ADSingleVariableReturnMappingSolution.C:393
ADSingleVariableReturnMappingSolution::_iteration
unsigned int _iteration
iteration number
Definition: ADSingleVariableReturnMappingSolution.h:193
ADPowerLawCreepStressUpdate::_gas_constant
const Real _gas_constant
Gas constant for exp term.
Definition: ADPowerLawCreepStressUpdate.h:61
ADPowerLawCreepStressUpdate::computeDerivative
virtual ADReal computeDerivative(const ADReal &effective_trial_stress, const ADReal &scalar) override
Compute the derivative of the residual as a function of the scalar variable.
Definition: ADPowerLawCreepStressUpdate.C:80
ADPowerLawCreepStressUpdate::validParams
static InputParameters validParams()
Definition: ADPowerLawCreepStressUpdate.C:18
ADPowerLawCreepStressUpdate::_start_time
const Real _start_time
Simulation start time.
Definition: ADPowerLawCreepStressUpdate.h:64
ADSingleVariableReturnMappingSolution::_initial_residual
ADReal _initial_residual
Residual values, kept as members to retain solver state for summary outputting.
Definition: ADSingleVariableReturnMappingSolution.h:196
ADRadialReturnCreepStressUpdateBase::_creep_strain_old
const MaterialProperty< RankTwoTensor > & _creep_strain_old
Definition: ADRadialReturnCreepStressUpdateBase.h:44
ADSingleVariableReturnMappingSolution::convergedAcceptable
bool convergedAcceptable(const unsigned int it, const Real reference)
Check to see whether the residual is within acceptable convergence limits.
Definition: ADSingleVariableReturnMappingSolution.C:311
ADSingleVariableReturnMappingSolution::_residual_history
std::vector< Real > _residual_history
History of residuals used to check whether progress is still being made on decreasing the residual.
Definition: ADSingleVariableReturnMappingSolution.h:190
ADSingleVariableReturnMappingSolution::maximumPermissibleValue
virtual ADReal maximumPermissibleValue(const ADReal &effective_trial_stress) const
Compute the maximum permissible value of the scalar.
Definition: ADSingleVariableReturnMappingSolution.C:93
ADRadialReturnStressUpdate::initQpStatefulProperties
virtual void initQpStatefulProperties() override
Definition: ADRadialReturnStressUpdate.C:54
ADSingleVariableReturnMappingSolution::_relative_tolerance
Real _relative_tolerance
Relative convergence tolerance.
Definition: ADSingleVariableReturnMappingSolution.h:178
ADPowerLawCreepStressUpdate::_temperature
const ADVariableValue * _temperature
Temperature variable value.
Definition: ADPowerLawCreepStressUpdate.h:46
ADPowerLawCreepStressUpdate::computeResidual
virtual ADReal computeResidual(const ADReal &effective_trial_stress, const ADReal &scalar) override
Compute the residual for a predicted value of the scalar.
Definition: ADPowerLawCreepStressUpdate.C:69
ADSingleVariableReturnMappingSolution::_internal_solve_output_on
enum ADSingleVariableReturnMappingSolution::InternalSolveOutput _internal_solve_output_on
ADRadialReturnStressUpdate::propagateQpStatefulPropertiesRadialReturn
void propagateQpStatefulPropertiesRadialReturn()
Propagate the properties pertaining to this intermediate class.
Definition: ADRadialReturnStressUpdate.C:61
ADSingleVariableReturnMappingSolution::_residual
ADReal _residual
Definition: ADSingleVariableReturnMappingSolution.h:197
ADSingleVariableReturnMappingSolution::_acceptable_multiplier
Real _acceptable_multiplier
Multiplier applied to relative and absolute tolerances for acceptable convergence.
Definition: ADSingleVariableReturnMappingSolution.h:184
ADSingleVariableReturnMappingSolution::converged
bool converged(const ADReal &residual, const Real reference)
Check to see whether the residual is within the convergence limits.
Definition: ADSingleVariableReturnMappingSolution.C:301
ADSingleVariableReturnMappingSolution::updateBounds
void updateBounds(const ADReal &scalar, const ADReal &residual, const Real init_resid_sign, ADReal &scalar_upper_bound, ADReal &scalar_lower_bound, std::stringstream *iter_output)
Update the upper and lower bounds of the root for the effective inelastic strain.
Definition: ADSingleVariableReturnMappingSolution.C:365
ADSingleVariableReturnMappingSolution::InternalSolveOutput::ALWAYS
ADPowerLawCreepStressUpdate
This class uses the stress update material in a radial return isotropic creep model.
Definition: ADPowerLawCreepStressUpdate.h:15
ADSingleVariableReturnMappingSolution::_max_its
const unsigned int _max_its
Maximum number of return mapping iterations.
Definition: ADSingleVariableReturnMappingSolution.h:172
ADSingleVariableReturnMappingSolution::checkPermissibleRange
void checkPermissibleRange(ADReal &scalar, ADReal &scalar_increment, const ADReal &scalar_old, const ADReal min_permissible_scalar, const ADReal max_permissible_scalar, std::stringstream *iter_output)
Check to see whether solution is within admissible range, and set it within that range if it is not.
Definition: ADSingleVariableReturnMappingSolution.C:334
ADSingleVariableReturnMappingSolution::iterationFinalize
virtual void iterationFinalize(ADReal)
Finalize internal state variables for a model for a given iteration.
Definition: ADSingleVariableReturnMappingSolution.h:114
ADSingleVariableReturnMappingSolution::minimumPermissibleValue
virtual ADReal minimumPermissibleValue(const ADReal &effective_trial_stress) const
Compute the minimum permissible value of the scalar.
Definition: ADSingleVariableReturnMappingSolution.C:85
ADRadialReturnStressUpdate::_three_shear_modulus
ADReal _three_shear_modulus
3 * shear modulus
Definition: ADRadialReturnStressUpdate.h:124
ADSingleVariableReturnMappingSolution::_check_range
bool _check_range
Whether to check to see whether iterative solution is within admissible range, and set within that ra...
Definition: ADSingleVariableReturnMappingSolution.h:124
ElasticityTensorTools::getIsotropicShearModulus
T getIsotropicShearModulus(const RankFourTensorTempl< T > &elasticity_tensor)
Get the shear modulus for an isotropic elasticity tensor param elasticity_tensor the tensor (must be ...
Definition: ElasticityTensorTools.h:71
ADRadialReturnStressUpdate::computeStressFinalize
virtual void computeStressFinalize(const ADRankTwoTensor &)
Perform any necessary steps to finalize state after return mapping iterations.
Definition: ADRadialReturnStressUpdate.h:118
ADPowerLawCreepStressUpdate::_exponential
ADReal _exponential
Exponential calculated from activiaction, gas constant, and temperature.
Definition: ADPowerLawCreepStressUpdate.h:67
ADRadialReturnStressUpdate::_max_inelastic_increment
Real _max_inelastic_increment
Definition: ADRadialReturnStressUpdate.h:128
ADSingleVariableReturnMappingSolution::_num_resids
const std::size_t _num_resids
Number of residuals to be stored in history.
Definition: ADSingleVariableReturnMappingSolution.h:187
ADSingleVariableReturnMappingSolution::SolveState::SUCCESS
ADPowerLawCreepStressUpdate::_exp_time
Real _exp_time
Exponential calculated from current time.
Definition: ADPowerLawCreepStressUpdate.h:70
ADSingleVariableReturnMappingSolution::_absolute_tolerance
Real _absolute_tolerance
Absolute convergence tolerance.
Definition: ADSingleVariableReturnMappingSolution.h:181
ADPowerLawCreepStressUpdate::_activation_energy
const Real _activation_energy
Activation energy for exp term.
Definition: ADPowerLawCreepStressUpdate.h:58
ADSingleVariableReturnMappingSolution::_line_search
bool _line_search
Whether to use line searches to improve convergence.
Definition: ADSingleVariableReturnMappingSolution.h:127
ADSingleVariableReturnMappingSolution::computeResidual
virtual ADReal computeResidual(const ADReal &effective_trial_stress, const ADReal &scalar)=0
Compute the residual for a predicted value of the scalar.
ADSingleVariableReturnMappingSolution::outputIterationSummary
virtual void outputIterationSummary(std::stringstream *iter_output, const unsigned int total_it)
Output summary information for the convergence history of the model.
Definition: ADSingleVariableReturnMappingSolution.C:416
ADSingleVariableReturnMappingSolution::internalSolve
SolveState internalSolve(const ADReal effective_trial_stress, ADReal &scalar, std::stringstream *iter_output=nullptr)
Method called from within this class to perform the actual return mappping iterations.
Definition: ADSingleVariableReturnMappingSolution.C:162
ADSingleVariableReturnMappingSolution::computeDerivative
virtual ADReal computeDerivative(const ADReal &effective_trial_stress, const ADReal &scalar)=0
Compute the derivative of the residual as a function of the scalar variable.
ADSingleVariableReturnMappingSolution::computeReferenceResidual
virtual Real computeReferenceResidual(const ADReal &effective_trial_stress, const ADReal &scalar)=0
Compute a reference quantity to be used for checking relative convergence.