#include <newmark_solver.h>
Public Types | |
typedef UnsteadySolver | Parent |
typedef DifferentiableSystem | sys_type |
Public Member Functions | |
NewmarkSolver (sys_type &s) | |
virtual | ~NewmarkSolver () |
virtual void | advance_timestep () override |
virtual void | adjoint_advance_timestep () override |
virtual void | compute_initial_accel () |
void | project_initial_accel (FunctionBase< Number > *f, FunctionBase< Gradient > *g=nullptr) |
void | set_initial_accel_avail (bool initial_accel_set) |
virtual Real | error_order () const override |
virtual void | solve () override |
virtual bool | element_residual (bool request_jacobian, DiffContext &) override |
virtual bool | side_residual (bool request_jacobian, DiffContext &) override |
virtual bool | nonlocal_residual (bool request_jacobian, DiffContext &) override |
void | set_beta (Real beta) |
void | set_gamma (Real gamma) |
virtual unsigned int | time_order () const override |
virtual void | init () override |
virtual void | init_data () override |
virtual void | reinit () override |
virtual void | retrieve_timestep () override |
void | project_initial_rate (FunctionBase< Number > *f, FunctionBase< Gradient > *g=nullptr) |
Number | old_solution_rate (const dof_id_type global_dof_number) const |
Number | old_solution_accel (const dof_id_type global_dof_number) const |
Number | old_nonlinear_solution (const dof_id_type global_dof_number) const |
virtual Real | du (const SystemNorm &norm) const override |
virtual bool | is_steady () const override |
virtual void | before_timestep () |
const sys_type & | system () const |
sys_type & | system () |
virtual std::unique_ptr< DiffSolver > & | diff_solver () |
virtual std::unique_ptr< LinearSolver< Number > > & | linear_solver () |
void | set_solution_history (const SolutionHistory &_solution_history) |
bool | is_adjoint () const |
void | set_is_adjoint (bool _is_adjoint_value) |
Static Public Member Functions | |
static std::string | get_info () |
static void | print_info (std::ostream &out=libMesh::out) |
static unsigned int | n_objects () |
static void | enable_print_counter_info () |
static void | disable_print_counter_info () |
Public Attributes | |
std::unique_ptr< NumericVector< Number > > | old_local_nonlinear_solution |
bool | quiet |
unsigned int | reduce_deltat_on_diffsolver_failure |
Protected Types | |
typedef bool(DifferentiablePhysics::* | ResFuncType) (bool, DiffContext &) |
typedef void(DiffContext::* | ReinitFuncType) (Real) |
typedef std::map< std::string, std::pair< unsigned int, unsigned int > > | Counts |
Protected Member Functions | |
virtual bool | _general_residual (bool request_jacobian, DiffContext &, ResFuncType mass, ResFuncType damping, ResFuncType time_deriv, ResFuncType constraint, ReinitFuncType reinit) |
void | increment_constructor_count (const std::string &name) |
void | increment_destructor_count (const std::string &name) |
Protected Attributes | |
Real | _beta |
Real | _gamma |
bool | _is_accel_solve |
bool | _initial_accel_set |
std::unique_ptr< NumericVector< Number > > | _old_local_solution_rate |
std::unique_ptr< NumericVector< Number > > | _old_local_solution_accel |
bool | first_solve |
bool | first_adjoint_step |
std::unique_ptr< DiffSolver > | _diff_solver |
std::unique_ptr< LinearSolver< Number > > | _linear_solver |
sys_type & | _system |
std::unique_ptr< SolutionHistory > | solution_history |
Static Protected Attributes | |
static Counts | _counts |
static Threads::atomic< unsigned int > | _n_objects |
static Threads::spin_mutex | _mutex |
static bool | _enable_print_counter = true |
This class defines a Newmark time integrator for second order (in time) DifferentiableSystems. There are two parameters and (defaulting to 0.5 and 0.25, respectively).
This class is part of the new DifferentiableSystem framework, which is still experimental. Users of this framework should beware of bugs and future API changes.
Definition at line 46 of file newmark_solver.h.
|
protectedinherited |
Data structure to log the information. The log is identified by the class name.
Definition at line 117 of file reference_counter.h.
The parent class
Definition at line 52 of file newmark_solver.h.
|
protectedinherited |
Definition at line 273 of file time_solver.h.
|
protectedinherited |
Definitions of argument types for use in refactoring subclasses.
Definition at line 271 of file time_solver.h.
|
inherited |
The type of system
Definition at line 65 of file time_solver.h.
|
explicit |
Constructor. Requires a reference to the system to be solved.
Definition at line 25 of file newmark_solver.C.
|
virtual |
|
protectedvirtual |
This method is the underlying implementation of the public residual methods.
Definition at line 205 of file newmark_solver.C.
References _beta, _gamma, _is_accel_solve, libMesh::TimeSolver::_system, libMesh::DenseVector< T >::add(), libMesh::DifferentiableSystem::deltat, libMesh::DiffContext::elem_solution_accel_derivative, libMesh::DiffContext::elem_solution_derivative, libMesh::DiffContext::elem_solution_rate_derivative, libMesh::DiffContext::get_dof_indices(), libMesh::DiffContext::get_elem_fixed_solution(), libMesh::DiffContext::get_elem_jacobian(), libMesh::DiffContext::get_elem_solution(), libMesh::DiffContext::get_elem_solution_accel(), libMesh::DiffContext::get_elem_solution_rate(), libMesh::DifferentiableSystem::get_physics(), libMesh::UnsteadySolver::old_nonlinear_solution(), libMesh::SecondOrderUnsteadySolver::old_solution_accel(), libMesh::SecondOrderUnsteadySolver::old_solution_rate(), libMesh::Real, libMesh::DenseVector< T >::size(), libMesh::DenseMatrix< T >::swap(), and libMesh::System::use_fixed_solution.
Referenced by element_residual(), nonlocal_residual(), and side_residual().
|
overridevirtual |
This method advances the adjoint solution to the previous timestep, after an adjoint_solve() has been performed. This will be done before every UnsteadySolver::adjoint_solve().
Reimplemented from libMesh::UnsteadySolver.
Definition at line 101 of file newmark_solver.C.
|
overridevirtual |
This method advances the solution to the next timestep, after a solve() has been performed. Often this will be done after every UnsteadySolver::solve(), but adaptive mesh refinement and/or adaptive time step selection may require some solve() steps to be repeated.
Reimplemented from libMesh::UnsteadySolver.
Definition at line 43 of file newmark_solver.C.
References _beta, _gamma, libMesh::SecondOrderUnsteadySolver::_old_local_solution_accel, libMesh::SecondOrderUnsteadySolver::_old_local_solution_rate, libMesh::TimeSolver::_system, libMesh::NumericVector< T >::add(), libMesh::UnsteadySolver::advance_timestep(), libMesh::NumericVector< T >::clone(), libMesh::DifferentiableSystem::deltat, libMesh::UnsteadySolver::first_solve, libMesh::System::get_dof_map(), libMesh::DofMap::get_send_list(), libMesh::System::get_vector(), libMesh::SecondOrderUnsteadySolver::old_solution_accel(), libMesh::SecondOrderUnsteadySolver::old_solution_rate(), and libMesh::System::solution.
|
inlinevirtualinherited |
This method is for subclasses or users to override to do arbitrary processing between timesteps
Definition at line 167 of file time_solver.h.
|
virtual |
This method uses the specified initial displacement and velocity to compute the initial acceleration .
Definition at line 106 of file newmark_solver.C.
References libMesh::TimeSolver::_diff_solver, _is_accel_solve, libMesh::TimeSolver::_system, libMesh::System::get_vector(), set_initial_accel_avail(), libMesh::System::solution, and libMesh::System::update().
|
inlinevirtualinherited |
An implicit linear or nonlinear solver to use at each timestep.
Reimplemented in libMesh::AdaptiveTimeSolver.
Definition at line 182 of file time_solver.h.
References libMesh::TimeSolver::_diff_solver.
Referenced by libMesh::TimeSolver::init(), libMesh::TimeSolver::init_data(), libMesh::TimeSolver::reinit(), and libMesh::TimeSolver::solve().
|
staticinherited |
Definition at line 106 of file reference_counter.C.
References libMesh::ReferenceCounter::_enable_print_counter.
Referenced by libMesh::LibMeshInit::LibMeshInit().
|
overridevirtualinherited |
Computes the size of ||u^{n+1} - u^{n}|| in some norm.
Implements libMesh::TimeSolver.
Definition at line 227 of file unsteady_solver.C.
References libMesh::TimeSolver::_system, libMesh::System::calculate_norm(), libMesh::System::get_vector(), and libMesh::System::solution.
|
overridevirtual |
This method uses the DifferentiablePhysics' element_time_derivative() and element_constraint() to build a full residual on an element. What combination it uses will depend on theta.
Implements libMesh::TimeSolver.
Definition at line 163 of file newmark_solver.C.
References libMesh::DifferentiablePhysics::_eulerian_time_deriv(), _general_residual(), libMesh::DifferentiablePhysics::damping_residual(), libMesh::DiffContext::elem_reinit(), libMesh::DifferentiablePhysics::element_constraint(), and libMesh::DifferentiablePhysics::mass_residual().
|
staticinherited |
Methods to enable/disable the reference counter output from print_info()
Definition at line 100 of file reference_counter.C.
References libMesh::ReferenceCounter::_enable_print_counter.
|
overridevirtual |
Error convergence order: 2 for , 1 otherwise
Implements libMesh::UnsteadySolver.
Definition at line 36 of file newmark_solver.C.
References _gamma.
|
staticinherited |
Gets a string containing the reference information.
Definition at line 47 of file reference_counter.C.
References libMesh::ReferenceCounter::_counts, and libMesh::Quality::name().
Referenced by libMesh::ReferenceCounter::print_info().
|
inlineprotectedinherited |
Increments the construction counter. Should be called in the constructor of any derived class that will be reference counted.
Definition at line 181 of file reference_counter.h.
References libMesh::ReferenceCounter::_counts, libMesh::Quality::name(), and libMesh::Threads::spin_mtx.
Referenced by libMesh::ReferenceCountedObject< RBParametrized >::ReferenceCountedObject().
|
inlineprotectedinherited |
Increments the destruction counter. Should be called in the destructor of any derived class that will be reference counted.
Definition at line 194 of file reference_counter.h.
References libMesh::ReferenceCounter::_counts, libMesh::Quality::name(), and libMesh::Threads::spin_mtx.
Referenced by libMesh::ReferenceCountedObject< RBParametrized >::~ReferenceCountedObject().
|
overridevirtualinherited |
The initialization function. This method is used to initialize internal data structures before a simulation begins.
Reimplemented from libMesh::UnsteadySolver.
Definition at line 34 of file second_order_unsteady_solver.C.
References libMesh::TimeSolver::_system, libMesh::System::add_vector(), and libMesh::UnsteadySolver::init().
|
overridevirtualinherited |
The data initialization function. This method is used to initialize internal data structures after the underlying System has been initialized
Reimplemented from libMesh::UnsteadySolver.
Definition at line 42 of file second_order_unsteady_solver.C.
References libMesh::SecondOrderUnsteadySolver::_old_local_solution_accel, libMesh::SecondOrderUnsteadySolver::_old_local_solution_rate, libMesh::TimeSolver::_system, libMesh::System::get_dof_map(), libMesh::DofMap::get_send_list(), libMesh::GHOSTED, libMesh::UnsteadySolver::init_data(), libMesh::System::n_dofs(), libMesh::System::n_local_dofs(), and libMesh::SERIAL.
|
inlineinherited |
Accessor for querying whether we need to do a primal or adjoint solve
Definition at line 233 of file time_solver.h.
References libMesh::TimeSolver::_is_adjoint.
Referenced by libMesh::FEMSystem::build_context().
|
inlineoverridevirtualinherited |
This is not a steady-state solver.
Implements libMesh::TimeSolver.
Definition at line 154 of file unsteady_solver.h.
|
inlinevirtualinherited |
An implicit linear solver to use for adjoint and sensitivity problems.
Reimplemented in libMesh::AdaptiveTimeSolver.
Definition at line 187 of file time_solver.h.
References libMesh::TimeSolver::_linear_solver.
Referenced by libMesh::TimeSolver::init(), libMesh::TimeSolver::init_data(), and libMesh::TimeSolver::reinit().
|
inlinestaticinherited |
Prints the number of outstanding (created, but not yet destroyed) objects.
Definition at line 83 of file reference_counter.h.
References libMesh::ReferenceCounter::_n_objects.
|
overridevirtual |
This method uses the DifferentiablePhysics' nonlocal_time_derivative() and nonlocal_constraint() to build a full residual for non-local terms. What combination it uses will depend on theta.
Implements libMesh::TimeSolver.
Definition at line 191 of file newmark_solver.C.
References _general_residual(), libMesh::DifferentiablePhysics::nonlocal_constraint(), libMesh::DifferentiablePhysics::nonlocal_damping_residual(), libMesh::DifferentiablePhysics::nonlocal_mass_residual(), libMesh::DiffContext::nonlocal_reinit(), and libMesh::DifferentiablePhysics::nonlocal_time_derivative().
|
inherited |
Definition at line 216 of file unsteady_solver.C.
References libMesh::TimeSolver::_system, libMesh::System::get_dof_map(), libMesh::DofMap::n_dofs(), and libMesh::UnsteadySolver::old_local_nonlinear_solution.
Referenced by libMesh::EulerSolver::_general_residual(), libMesh::Euler2Solver::_general_residual(), and _general_residual().
|
inherited |
Definition at line 116 of file second_order_unsteady_solver.C.
References libMesh::SecondOrderUnsteadySolver::_old_local_solution_accel, libMesh::TimeSolver::_system, libMesh::System::get_dof_map(), and libMesh::DofMap::n_dofs().
Referenced by _general_residual(), advance_timestep(), project_initial_accel(), and libMesh::SecondOrderUnsteadySolver::reinit().
|
inherited |
Definition at line 107 of file second_order_unsteady_solver.C.
References libMesh::SecondOrderUnsteadySolver::_old_local_solution_rate, libMesh::TimeSolver::_system, libMesh::System::get_dof_map(), and libMesh::DofMap::n_dofs().
Referenced by _general_residual(), advance_timestep(), libMesh::SecondOrderUnsteadySolver::project_initial_rate(), and libMesh::SecondOrderUnsteadySolver::reinit().
|
staticinherited |
Prints the reference information, by default to libMesh::out
.
Definition at line 87 of file reference_counter.C.
References libMesh::ReferenceCounter::_enable_print_counter, and libMesh::ReferenceCounter::get_info().
void libMesh::NewmarkSolver::project_initial_accel | ( | FunctionBase< Number > * | f, |
FunctionBase< Gradient > * | g = nullptr |
||
) |
Specify non-zero initial acceleration. Should be called before solve(). This is an alternative to compute_initial_acceleration() if the initial acceleration is actually known. The function value f and its gradient g are user-provided cloneable functors. A gradient g is only required/used for projecting onto finite element spaces with continuous derivatives.
Definition at line 132 of file newmark_solver.C.
References libMesh::TimeSolver::_system, libMesh::System::get_vector(), libMesh::SecondOrderUnsteadySolver::old_solution_accel(), libMesh::System::project_vector(), and set_initial_accel_avail().
|
inherited |
Specify non-zero initial velocity. Should be called before solve(). The function value f and its gradient g are user-provided cloneable functors. A gradient g is only required/used for projecting onto finite element spaces with continuous derivatives.
Definition at line 98 of file second_order_unsteady_solver.C.
References libMesh::TimeSolver::_system, libMesh::System::get_vector(), libMesh::SecondOrderUnsteadySolver::old_solution_rate(), and libMesh::System::project_vector().
|
overridevirtualinherited |
The reinitialization function. This method is used to resize internal data vectors after a mesh change.
Reimplemented from libMesh::UnsteadySolver.
Definition at line 60 of file second_order_unsteady_solver.C.
References libMesh::SecondOrderUnsteadySolver::_old_local_solution_accel, libMesh::SecondOrderUnsteadySolver::_old_local_solution_rate, libMesh::TimeSolver::_system, libMesh::System::get_dof_map(), libMesh::DofMap::get_send_list(), libMesh::System::get_vector(), libMesh::GHOSTED, libMesh::System::n_dofs(), libMesh::System::n_local_dofs(), libMesh::SecondOrderUnsteadySolver::old_solution_accel(), libMesh::SecondOrderUnsteadySolver::old_solution_rate(), libMesh::UnsteadySolver::reinit(), and libMesh::SERIAL.
|
overridevirtualinherited |
This method retrieves all the stored solutions at the current system.time
Reimplemented from libMesh::UnsteadySolver.
Definition at line 93 of file second_order_unsteady_solver.C.
|
inline |
|
inline |
Setter for .
Definition at line 157 of file newmark_solver.h.
References _gamma.
void libMesh::NewmarkSolver::set_initial_accel_avail | ( | bool | initial_accel_set | ) |
Allow the user to (re)set whether the initial acceleration is available. This is not needed if either compute_initial_accel() or project_initial_accel() are called. This is useful is the user is restarting a calculation and the acceleration is available from the restart.
Definition at line 143 of file newmark_solver.C.
References _initial_accel_set.
Referenced by compute_initial_accel(), and project_initial_accel().
|
inlineinherited |
Accessor for setting whether we need to do a primal or adjoint solve
Definition at line 240 of file time_solver.h.
References libMesh::TimeSolver::_is_adjoint.
Referenced by libMesh::DifferentiableSystem::adjoint_solve(), libMesh::FEMSystem::postprocess(), and libMesh::DifferentiableSystem::solve().
|
inherited |
A setter function users will employ if they need to do something other than save no solution history
Definition at line 97 of file time_solver.C.
References libMesh::SolutionHistory::clone(), and libMesh::TimeSolver::solution_history.
|
overridevirtual |
This method uses the DifferentiablePhysics' side_time_derivative() and side_constraint() to build a full residual on an element's side. What combination it uses will depend on theta.
Implements libMesh::TimeSolver.
Definition at line 177 of file newmark_solver.C.
References _general_residual(), libMesh::DiffContext::elem_side_reinit(), libMesh::DifferentiablePhysics::side_constraint(), libMesh::DifferentiablePhysics::side_damping_residual(), libMesh::DifferentiablePhysics::side_mass_residual(), and libMesh::DifferentiablePhysics::side_time_derivative().
|
overridevirtual |
This method solves for the solution at the next timestep. Usually we will only need to solve one (non)linear system per timestep, but more complex subclasses may override this.
Reimplemented from libMesh::UnsteadySolver.
Definition at line 148 of file newmark_solver.C.
References _initial_accel_set, and libMesh::UnsteadySolver::solve().
|
inlineinherited |
Definition at line 172 of file time_solver.h.
References libMesh::TimeSolver::_system.
Referenced by libMesh::TimeSolver::reinit(), and libMesh::TimeSolver::solve().
|
inlineinherited |
Definition at line 177 of file time_solver.h.
References libMesh::TimeSolver::_system.
|
inlineoverridevirtualinherited |
For example, EulerSolver will have time_order()
= 1 and NewmarkSolver will have time_order()
= 2.
Implements libMesh::UnsteadySolver.
Definition at line 53 of file second_order_unsteady_solver.h.
|
protected |
The value for the to employ. Method is unconditionally stable for
Definition at line 167 of file newmark_solver.h.
Referenced by _general_residual(), advance_timestep(), and set_beta().
|
staticprotectedinherited |
Actually holds the data.
Definition at line 122 of file reference_counter.h.
Referenced by libMesh::ReferenceCounter::get_info(), libMesh::ReferenceCounter::increment_constructor_count(), and libMesh::ReferenceCounter::increment_destructor_count().
|
protectedinherited |
An implicit linear or nonlinear solver to use at each timestep.
Definition at line 248 of file time_solver.h.
Referenced by compute_initial_accel(), libMesh::TimeSolver::diff_solver(), and libMesh::UnsteadySolver::solve().
|
staticprotectedinherited |
Flag to control whether reference count information is printed when print_info is called.
Definition at line 141 of file reference_counter.h.
Referenced by libMesh::ReferenceCounter::disable_print_counter_info(), libMesh::ReferenceCounter::enable_print_counter_info(), and libMesh::ReferenceCounter::print_info().
|
protected |
The value for to employ. Newmark is 2nd order iff .
Definition at line 173 of file newmark_solver.h.
Referenced by _general_residual(), advance_timestep(), error_order(), and set_gamma().
|
protected |
This method requires an initial acceleration. So, we force the user to call either compute_initial_accel or project_initial_accel to set the initial acceleration.
Definition at line 187 of file newmark_solver.h.
Referenced by set_initial_accel_avail(), and solve().
|
protected |
Need to be able to indicate to _general_residual if we are doing an acceleration solve or not.
Definition at line 179 of file newmark_solver.h.
Referenced by _general_residual(), and compute_initial_accel().
|
protectedinherited |
An implicit linear solver to use for adjoint problems.
Definition at line 253 of file time_solver.h.
Referenced by libMesh::TimeSolver::linear_solver().
|
staticprotectedinherited |
Mutual exclusion object to enable thread-safe reference counting.
Definition at line 135 of file reference_counter.h.
|
staticprotectedinherited |
The number of objects. Print the reference count information when the number returns to 0.
Definition at line 130 of file reference_counter.h.
Referenced by libMesh::ReferenceCounter::n_objects(), libMesh::ReferenceCounter::ReferenceCounter(), and libMesh::ReferenceCounter::~ReferenceCounter().
|
protectedinherited |
Serial vector of previous time step acceleration
Definition at line 112 of file second_order_unsteady_solver.h.
Referenced by advance_timestep(), libMesh::SecondOrderUnsteadySolver::init_data(), libMesh::SecondOrderUnsteadySolver::old_solution_accel(), and libMesh::SecondOrderUnsteadySolver::reinit().
|
protectedinherited |
Serial vector of previous time step velocity
Definition at line 107 of file second_order_unsteady_solver.h.
Referenced by advance_timestep(), libMesh::SecondOrderUnsteadySolver::init_data(), libMesh::SecondOrderUnsteadySolver::old_solution_rate(), and libMesh::SecondOrderUnsteadySolver::reinit().
|
protectedinherited |
A reference to the system we are solving.
Definition at line 258 of file time_solver.h.
Referenced by libMesh::EulerSolver::_general_residual(), libMesh::Euler2Solver::_general_residual(), libMesh::SteadySolver::_general_residual(), _general_residual(), libMesh::UnsteadySolver::adjoint_advance_timestep(), advance_timestep(), libMesh::AdaptiveTimeSolver::advance_timestep(), libMesh::UnsteadySolver::advance_timestep(), compute_initial_accel(), libMesh::FirstOrderUnsteadySolver::compute_second_order_eqns(), libMesh::UnsteadySolver::du(), libMesh::EulerSolver::element_residual(), libMesh::Euler2Solver::element_residual(), libMesh::EigenTimeSolver::element_residual(), libMesh::SecondOrderUnsteadySolver::init(), libMesh::UnsteadySolver::init(), libMesh::TimeSolver::init(), libMesh::EigenTimeSolver::init(), libMesh::SecondOrderUnsteadySolver::init_data(), libMesh::UnsteadySolver::init_data(), libMesh::TimeSolver::init_data(), libMesh::EulerSolver::nonlocal_residual(), libMesh::Euler2Solver::nonlocal_residual(), libMesh::EigenTimeSolver::nonlocal_residual(), libMesh::UnsteadySolver::old_nonlinear_solution(), libMesh::SecondOrderUnsteadySolver::old_solution_accel(), libMesh::SecondOrderUnsteadySolver::old_solution_rate(), project_initial_accel(), libMesh::SecondOrderUnsteadySolver::project_initial_rate(), libMesh::SecondOrderUnsteadySolver::reinit(), libMesh::UnsteadySolver::reinit(), libMesh::TimeSolver::reinit(), libMesh::UnsteadySolver::retrieve_timestep(), libMesh::EigenTimeSolver::side_residual(), libMesh::TwostepTimeSolver::solve(), libMesh::UnsteadySolver::solve(), libMesh::EigenTimeSolver::solve(), and libMesh::TimeSolver::system().
|
protectedinherited |
A bool that will be true the first time adjoint_advance_timestep() is called, (when the primal solution is to be used to set adjoint boundary conditions) and false thereafter
Definition at line 168 of file unsteady_solver.h.
Referenced by libMesh::UnsteadySolver::adjoint_advance_timestep().
|
protectedinherited |
A bool that will be true the first time solve() is called, and false thereafter
Definition at line 162 of file unsteady_solver.h.
Referenced by advance_timestep(), libMesh::AdaptiveTimeSolver::advance_timestep(), libMesh::UnsteadySolver::advance_timestep(), libMesh::TwostepTimeSolver::solve(), and libMesh::UnsteadySolver::solve().
|
inherited |
Serial vector of _system.get_vector("_old_nonlinear_solution")
Definition at line 138 of file unsteady_solver.h.
Referenced by libMesh::AdaptiveTimeSolver::AdaptiveTimeSolver(), libMesh::UnsteadySolver::adjoint_advance_timestep(), libMesh::UnsteadySolver::advance_timestep(), libMesh::AdaptiveTimeSolver::init(), libMesh::UnsteadySolver::init_data(), libMesh::UnsteadySolver::old_nonlinear_solution(), libMesh::UnsteadySolver::reinit(), libMesh::UnsteadySolver::retrieve_timestep(), and libMesh::AdaptiveTimeSolver::~AdaptiveTimeSolver().
|
inherited |
Print extra debugging information if quiet == false.
Definition at line 192 of file time_solver.h.
Referenced by libMesh::TwostepTimeSolver::solve(), libMesh::UnsteadySolver::solve(), and libMesh::EigenTimeSolver::solve().
|
inherited |
This value (which defaults to zero) is the number of times the TimeSolver is allowed to halve deltat and let the DiffSolver repeat the latest failed solve with a reduced timestep.
Definition at line 221 of file time_solver.h.
Referenced by libMesh::TwostepTimeSolver::solve(), and libMesh::UnsteadySolver::solve().
|
protectedinherited |
A std::unique_ptr to a SolutionHistory object. Default is NoSolutionHistory, which the user can override by declaring a different kind of SolutionHistory in the application
Definition at line 265 of file time_solver.h.
Referenced by libMesh::UnsteadySolver::adjoint_advance_timestep(), libMesh::UnsteadySolver::advance_timestep(), libMesh::UnsteadySolver::retrieve_timestep(), and libMesh::TimeSolver::set_solution_history().