libMesh
|
Generic class from which second order UnsteadySolvers should subclass. More...
#include <second_order_unsteady_solver.h>
Public Types | |
typedef DifferentiableSystem | sys_type |
The type of system. More... | |
Public Member Functions | |
SecondOrderUnsteadySolver (sys_type &s) | |
Constructor. More... | |
virtual | ~SecondOrderUnsteadySolver () |
Destructor. More... | |
virtual unsigned int | time_order () const override |
virtual void | init () override |
The initialization function. More... | |
virtual void | init_data () override |
The data initialization function. More... | |
virtual void | reinit () override |
The reinitialization function. More... | |
virtual void | retrieve_timestep () override |
This method retrieves all the stored solutions at the current system.time. More... | |
void | project_initial_rate (FunctionBase< Number > *f, FunctionBase< Gradient > *g=nullptr) |
Specify non-zero initial velocity. More... | |
Number | old_solution_rate (const dof_id_type global_dof_number) const |
Number | old_solution_accel (const dof_id_type global_dof_number) const |
virtual void | solve () override |
This method solves for the solution at the next timestep. More... | |
virtual void | advance_timestep () override |
This method advances the solution to the next timestep, after a solve() has been performed. More... | |
virtual void | adjoint_advance_timestep () override |
This method advances the adjoint solution to the previous timestep, after an adjoint_solve() has been performed. More... | |
virtual Real | error_order () const =0 |
This method should return the expected convergence order of the (non-local) error of the time discretization scheme - e.g. More... | |
Number | old_nonlinear_solution (const dof_id_type global_dof_number) const |
virtual Real | du (const SystemNorm &norm) const override |
Computes the size of ||u^{n+1} - u^{n}|| in some norm. More... | |
virtual bool | is_steady () const override |
This is not a steady-state solver. More... | |
virtual bool | element_residual (bool request_jacobian, DiffContext &)=0 |
This method uses the DifferentiablePhysics element_time_derivative(), element_constraint(), and mass_residual() to build a full residual on an element. More... | |
virtual bool | side_residual (bool request_jacobian, DiffContext &)=0 |
This method uses the DifferentiablePhysics side_time_derivative(), side_constraint(), and side_mass_residual() to build a full residual on an element's side. More... | |
virtual bool | nonlocal_residual (bool request_jacobian, DiffContext &)=0 |
This method uses the DifferentiablePhysics nonlocal_time_derivative(), nonlocal_constraint(), and nonlocal_mass_residual() to build a full residual of non-local terms. More... | |
virtual void | before_timestep () |
This method is for subclasses or users to override to do arbitrary processing between timesteps. More... | |
const sys_type & | system () const |
sys_type & | system () |
virtual std::unique_ptr< DiffSolver > & | diff_solver () |
An implicit linear or nonlinear solver to use at each timestep. More... | |
virtual std::unique_ptr< LinearSolver< Number > > & | linear_solver () |
An implicit linear solver to use for adjoint and sensitivity problems. More... | |
void | set_solution_history (const SolutionHistory &_solution_history) |
A setter function users will employ if they need to do something other than save no solution history. More... | |
bool | is_adjoint () const |
Accessor for querying whether we need to do a primal or adjoint solve. More... | |
void | set_is_adjoint (bool _is_adjoint_value) |
Accessor for setting whether we need to do a primal or adjoint solve. More... | |
Static Public Member Functions | |
static std::string | get_info () |
Gets a string containing the reference information. More... | |
static void | print_info (std::ostream &out=libMesh::out) |
Prints the reference information, by default to libMesh::out . More... | |
static unsigned int | n_objects () |
Prints the number of outstanding (created, but not yet destroyed) objects. More... | |
static void | enable_print_counter_info () |
Methods to enable/disable the reference counter output from print_info() More... | |
static void | disable_print_counter_info () |
Public Attributes | |
std::unique_ptr< NumericVector< Number > > | old_local_nonlinear_solution |
Serial vector of _system.get_vector("_old_nonlinear_solution") More... | |
bool | quiet |
Print extra debugging information if quiet == false. More... | |
unsigned int | reduce_deltat_on_diffsolver_failure |
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. More... | |
Protected Types | |
typedef bool(DifferentiablePhysics::* | ResFuncType) (bool, DiffContext &) |
Definitions of argument types for use in refactoring subclasses. More... | |
typedef void(DiffContext::* | ReinitFuncType) (Real) |
typedef std::map< std::string, std::pair< unsigned int, unsigned int > > | Counts |
Data structure to log the information. More... | |
Protected Member Functions | |
void | increment_constructor_count (const std::string &name) |
Increments the construction counter. More... | |
void | increment_destructor_count (const std::string &name) |
Increments the destruction counter. More... | |
Protected Attributes | |
std::unique_ptr< NumericVector< Number > > | _old_local_solution_rate |
Serial vector of previous time step velocity \( \dot{u}_n \). More... | |
std::unique_ptr< NumericVector< Number > > | _old_local_solution_accel |
Serial vector of previous time step acceleration \( \ddot{u}_n \). More... | |
bool | first_solve |
A bool that will be true the first time solve() is called, and false thereafter. More... | |
bool | first_adjoint_step |
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. More... | |
std::unique_ptr< DiffSolver > | _diff_solver |
An implicit linear or nonlinear solver to use at each timestep. More... | |
std::unique_ptr< LinearSolver< Number > > | _linear_solver |
An implicit linear solver to use for adjoint problems. More... | |
sys_type & | _system |
A reference to the system we are solving. More... | |
std::unique_ptr< SolutionHistory > | solution_history |
A std::unique_ptr to a SolutionHistory object. More... | |
Static Protected Attributes | |
static Counts | _counts |
Actually holds the data. More... | |
static Threads::atomic< unsigned int > | _n_objects |
The number of objects. More... | |
static Threads::spin_mutex | _mutex |
Mutual exclusion object to enable thread-safe reference counting. More... | |
static bool | _enable_print_counter = true |
Flag to control whether reference count information is printed when print_info is called. More... | |
Private Attributes | |
bool | _is_adjoint |
This boolean tells the TimeSolver whether we are solving a primal or adjoint problem. More... | |
Generic class from which second order UnsteadySolvers should subclass.
Subclasses of this class are meant to solve problems of the form
\[ M(u)\ddot{u} + C(u)\dot{u} + F(u) = 0 \]
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 38 of file second_order_unsteady_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.
|
protectedinherited |
Definition at line 272 of file time_solver.h.
|
protectedinherited |
Definitions of argument types for use in refactoring subclasses.
Definition at line 270 of file time_solver.h.
|
inherited |
The type of system.
Definition at line 64 of file time_solver.h.
|
explicit |
Constructor.
Requires a reference to the system to be solved.
Definition at line 25 of file second_order_unsteady_solver.C.
|
virtual |
|
overridevirtualinherited |
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::TimeSolver.
Reimplemented in libMesh::NewmarkSolver.
Definition at line 178 of file unsteady_solver.C.
References libMesh::TimeSolver::_system, libMesh::DifferentiableSystem::deltat, libMesh::UnsteadySolver::first_adjoint_step, libMesh::System::get_dof_map(), libMesh::DofMap::get_send_list(), libMesh::System::get_vector(), libMesh::NumericVector< T >::localize(), libMesh::UnsteadySolver::old_local_nonlinear_solution, libMesh::TimeSolver::solution_history, and libMesh::System::time.
|
overridevirtualinherited |
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::TimeSolver.
Reimplemented in libMesh::AdaptiveTimeSolver, and libMesh::NewmarkSolver.
Definition at line 152 of file unsteady_solver.C.
References libMesh::TimeSolver::_system, libMesh::DifferentiableSystem::deltat, libMesh::UnsteadySolver::first_solve, libMesh::System::get_dof_map(), libMesh::DofMap::get_send_list(), libMesh::System::get_vector(), libMesh::NumericVector< T >::localize(), libMesh::UnsteadySolver::old_local_nonlinear_solution, libMesh::System::solution, libMesh::TimeSolver::solution_history, and libMesh::System::time.
Referenced by libMesh::NewmarkSolver::advance_timestep(), and libMesh::UnsteadySolver::solve().
|
inlinevirtualinherited |
This method is for subclasses or users to override to do arbitrary processing between timesteps.
Definition at line 166 of file time_solver.h.
|
inlinevirtualinherited |
An implicit linear or nonlinear solver to use at each timestep.
Reimplemented in libMesh::AdaptiveTimeSolver.
Definition at line 181 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(), std::norm(), and libMesh::System::solution.
|
pure virtualinherited |
This method uses the DifferentiablePhysics element_time_derivative(), element_constraint(), and mass_residual() to build a full residual on an element.
What combination
it uses will depend on the type of solver. See the subclasses for more details.
Implemented in libMesh::NewmarkSolver, libMesh::SteadySolver, libMesh::Euler2Solver, libMesh::EulerSolver, libMesh::EigenTimeSolver, and libMesh::AdaptiveTimeSolver.
Referenced by libMesh::FEMSystem::numerical_elem_jacobian().
|
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.
|
pure virtualinherited |
This method should return the expected convergence order of the (non-local) error of the time discretization scheme - e.g.
2 for the O(deltat^2) Crank-Nicholson, or 1 for the O(deltat) Backward Euler.
Useful for adaptive timestepping schemes.
Implemented in libMesh::NewmarkSolver, libMesh::AdaptiveTimeSolver, libMesh::Euler2Solver, and libMesh::EulerSolver.
|
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().
|
overridevirtual |
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().
|
overridevirtual |
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 _old_local_solution_accel, _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 232 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 153 of file unsteady_solver.h.
|
inlinevirtualinherited |
An implicit linear solver to use for adjoint and sensitivity problems.
Reimplemented in libMesh::AdaptiveTimeSolver.
Definition at line 186 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.
|
pure virtualinherited |
This method uses the DifferentiablePhysics nonlocal_time_derivative(), nonlocal_constraint(), and nonlocal_mass_residual() to build a full residual of non-local terms.
What combination it uses will depend on the type of solver. See the subclasses for more details.
Implemented in libMesh::NewmarkSolver, libMesh::SteadySolver, libMesh::Euler2Solver, libMesh::EulerSolver, libMesh::EigenTimeSolver, and libMesh::AdaptiveTimeSolver.
Referenced by libMesh::FEMSystem::numerical_nonlocal_jacobian().
|
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(), libMesh::NewmarkSolver::_general_residual(), and libMesh::FEMPhysics::eulerian_residual().
Number libMesh::SecondOrderUnsteadySolver::old_solution_accel | ( | const dof_id_type | global_dof_number | ) | const |
Definition at line 116 of file second_order_unsteady_solver.C.
References _old_local_solution_accel, libMesh::TimeSolver::_system, libMesh::System::get_dof_map(), and libMesh::DofMap::n_dofs().
Referenced by libMesh::NewmarkSolver::_general_residual(), libMesh::NewmarkSolver::advance_timestep(), libMesh::NewmarkSolver::project_initial_accel(), and reinit().
Number libMesh::SecondOrderUnsteadySolver::old_solution_rate | ( | const dof_id_type | global_dof_number | ) | const |
Definition at line 107 of file second_order_unsteady_solver.C.
References _old_local_solution_rate, libMesh::TimeSolver::_system, libMesh::System::get_dof_map(), and libMesh::DofMap::n_dofs().
Referenced by libMesh::NewmarkSolver::_general_residual(), libMesh::NewmarkSolver::advance_timestep(), project_initial_rate(), and 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::SecondOrderUnsteadySolver::project_initial_rate | ( | FunctionBase< Number > * | f, |
FunctionBase< Gradient > * | g = nullptr |
||
) |
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(), old_solution_rate(), and libMesh::System::project_vector().
|
overridevirtual |
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 _old_local_solution_accel, _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(), old_solution_accel(), old_solution_rate(), libMesh::UnsteadySolver::reinit(), and libMesh::SERIAL.
|
overridevirtual |
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.
|
inlineinherited |
Accessor for setting whether we need to do a primal or adjoint solve.
Definition at line 239 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 96 of file time_solver.C.
References libMesh::SolutionHistory::clone(), and libMesh::TimeSolver::solution_history.
|
pure virtualinherited |
This method uses the DifferentiablePhysics side_time_derivative(), side_constraint(), and side_mass_residual() to build a full residual on an element's side.
What combination it uses will depend on the type of solver. See the subclasses for more details.
Implemented in libMesh::NewmarkSolver, libMesh::SteadySolver, libMesh::Euler2Solver, libMesh::EulerSolver, libMesh::EigenTimeSolver, and libMesh::AdaptiveTimeSolver.
Referenced by libMesh::FEMSystem::numerical_side_jacobian().
|
overridevirtualinherited |
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::TimeSolver.
Reimplemented in libMesh::AdaptiveTimeSolver, libMesh::NewmarkSolver, and libMesh::TwostepTimeSolver.
Definition at line 93 of file unsteady_solver.C.
References libMesh::TimeSolver::_diff_solver, libMesh::TimeSolver::_system, libMesh::UnsteadySolver::advance_timestep(), libMesh::DifferentiableSystem::deltat, libMesh::DiffSolver::DIVERGED_BACKTRACKING_FAILURE, libMesh::DiffSolver::DIVERGED_MAX_NONLINEAR_ITERATIONS, libMesh::UnsteadySolver::first_solve, libMesh::out, libMesh::TimeSolver::quiet, and libMesh::TimeSolver::reduce_deltat_on_diffsolver_failure.
Referenced by libMesh::NewmarkSolver::solve().
|
inlineinherited |
Definition at line 176 of file time_solver.h.
References libMesh::TimeSolver::_system.
|
inlineinherited |
Definition at line 171 of file time_solver.h.
References libMesh::TimeSolver::_system.
Referenced by libMesh::TimeSolver::reinit(), and libMesh::TimeSolver::solve().
|
inlineoverridevirtual |
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.
|
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 247 of file time_solver.h.
Referenced by libMesh::NewmarkSolver::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().
|
privateinherited |
This boolean tells the TimeSolver whether we are solving a primal or adjoint problem.
Definition at line 280 of file time_solver.h.
Referenced by libMesh::TimeSolver::is_adjoint(), and libMesh::TimeSolver::set_is_adjoint().
|
protectedinherited |
An implicit linear solver to use for adjoint problems.
Definition at line 252 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().
|
protected |
Serial vector of previous time step acceleration \( \ddot{u}_n \).
Definition at line 112 of file second_order_unsteady_solver.h.
Referenced by libMesh::NewmarkSolver::advance_timestep(), init_data(), old_solution_accel(), and reinit().
|
protected |
Serial vector of previous time step velocity \( \dot{u}_n \).
Definition at line 107 of file second_order_unsteady_solver.h.
Referenced by libMesh::NewmarkSolver::advance_timestep(), init_data(), old_solution_rate(), and reinit().
|
protectedinherited |
A reference to the system we are solving.
Definition at line 257 of file time_solver.h.
Referenced by libMesh::EulerSolver::_general_residual(), libMesh::Euler2Solver::_general_residual(), libMesh::SteadySolver::_general_residual(), libMesh::NewmarkSolver::_general_residual(), libMesh::UnsteadySolver::adjoint_advance_timestep(), libMesh::NewmarkSolver::advance_timestep(), libMesh::AdaptiveTimeSolver::advance_timestep(), libMesh::UnsteadySolver::advance_timestep(), libMesh::NewmarkSolver::compute_initial_accel(), libMesh::FirstOrderUnsteadySolver::compute_second_order_eqns(), libMesh::UnsteadySolver::du(), libMesh::EulerSolver::element_residual(), libMesh::Euler2Solver::element_residual(), libMesh::EigenTimeSolver::element_residual(), init(), libMesh::UnsteadySolver::init(), libMesh::TimeSolver::init(), libMesh::EigenTimeSolver::init(), 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(), old_solution_accel(), old_solution_rate(), libMesh::NewmarkSolver::project_initial_accel(), project_initial_rate(), 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 167 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 161 of file unsteady_solver.h.
Referenced by libMesh::NewmarkSolver::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 137 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 191 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 220 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 264 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().