oomph::SegregatableFSIProblem Member List

This is the complete list of members for oomph::SegregatableFSIProblem, including all inherited members.

actions_after_adapt()oomph::Probleminlinevirtual
actions_after_change_in_bifurcation_parameter()oomph::Probleminlineprotectedvirtual
actions_after_change_in_global_parameter(double *const &parameter_pt)oomph::Probleminlineprotectedvirtual
actions_after_distribute()oomph::Probleminlineprotectedvirtual
actions_after_explicit_stage()oomph::ExplicitTimeSteppableObjectinlinevirtual
actions_after_explicit_timestep()oomph::Probleminlineprotectedvirtual
actions_after_implicit_timestep()oomph::Probleminlineprotectedvirtual
actions_after_implicit_timestep_and_error_estimation()oomph::Probleminlineprotectedvirtual
actions_after_newton_solve()oomph::Probleminlineprotectedvirtual
actions_after_newton_step()oomph::Probleminlineprotectedvirtual
actions_after_parameter_increase(double *const &parameter_pt)oomph::Probleminlineprotectedvirtual
actions_after_read_unstructured_meshes()oomph::Probleminlineprotectedvirtual
actions_after_segregated_solve()oomph::SegregatableFSIProbleminlineprotectedvirtual
actions_before_adapt()oomph::Probleminlinevirtual
actions_before_distribute()oomph::Probleminlineprotectedvirtual
actions_before_explicit_stage()oomph::ExplicitTimeSteppableObjectinlinevirtual
actions_before_explicit_timestep()oomph::Probleminlineprotectedvirtual
actions_before_implicit_timestep()oomph::Probleminlineprotectedvirtual
actions_before_newton_convergence_check()oomph::Probleminlineprotectedvirtual
actions_before_newton_solve()oomph::Probleminlineprotectedvirtual
actions_before_newton_step()oomph::Probleminlineprotectedvirtual
actions_before_read_unstructured_meshes()oomph::Probleminlineprotectedvirtual
actions_before_segregated_convergence_check()oomph::SegregatableFSIProbleminlineprotectedvirtual
actions_before_segregated_solve()oomph::SegregatableFSIProbleminlineprotectedvirtual
activate_bifurcation_tracking(double *const &parameter_pt, const DoubleVector &eigenvector, const bool &block_solve=true)oomph::Problem
activate_bifurcation_tracking(double *const &parameter_pt, const DoubleVector &eigenvector, const DoubleVector &normalisation, const bool &block_solve=true)oomph::Problem
activate_fold_tracking(double *const &parameter_pt, const bool &block_solve=true)oomph::Problem
activate_hopf_tracking(double *const &parameter_pt, const bool &block_solve=true)oomph::Problem
activate_hopf_tracking(double *const &parameter_pt, const double &omega, const DoubleVector &null_real, const DoubleVector &null_imag, const bool &block_solve=true)oomph::Problem
activate_pitchfork_tracking(double *const &parameter_pt, const DoubleVector &symmetry_vector, const bool &block_solve=true)oomph::Problem
adapt(unsigned &n_refined, unsigned &n_unrefined)oomph::Problem
adapt()oomph::Probleminline
adapt_based_on_error_estimates(unsigned &n_refined, unsigned &n_unrefined, Vector< Vector< double >> &elemental_error)oomph::Problem
adapt_based_on_error_estimates(Vector< Vector< double >> &elemental_error)oomph::Probleminline
adaptive_unsteady_newton_solve(const double &dt_desired, const double &epsilon)oomph::Problem
adaptive_unsteady_newton_solve(const double &dt_desired, const double &epsilon, const bool &shift_values)oomph::Problem
add_eigenvector_to_dofs(const double &epsilon, const DoubleVector &eigenvector)oomph::Problem
add_global_data(Data *const &global_data_pt)oomph::Probleminline
add_sub_mesh(Mesh *const &mesh_pt)oomph::Probleminline
add_time_stepper_pt(TimeStepper *const &time_stepper_pt)oomph::Problem
add_to_dofs(const double &lambda, const DoubleVector &increment_dofs)oomph::Problemvirtual
Always_take_one_newton_stepoomph::Problemprotected
arc_length_step_solve(double *const &parameter_pt, const double &ds, const unsigned &max_adapt=0)oomph::Problem
arc_length_step_solve(Data *const &data_pt, const unsigned &data_index, const double &ds, const unsigned &max_adapt=0)oomph::Problem
arc_length_step_solve_helper(double *const &parameter_pt, const double &ds, const unsigned &max_adapt)oomph::Problemprivate
Arc_length_step_takenoomph::Problemprotected
are_hessian_products_calculated_analytically()oomph::Probleminline
Assembly_handler_ptoomph::Problemprivate
assembly_handler_pt()oomph::Probleminline
assembly_handler_pt() constoomph::Probleminline
Assembly_method enum nameoomph::Problemprotected
Assess_convergence_based_on_absolute_solid_change enum valueoomph::SegregatableFSIProblem
assess_convergence_based_on_absolute_solid_change(const double &tol)oomph::SegregatableFSIProbleminline
assess_convergence_based_on_absolute_solid_change()oomph::SegregatableFSIProbleminline
Assess_convergence_based_on_max_global_residual enum valueoomph::SegregatableFSIProblem
assess_convergence_based_on_max_global_residual(const double &tol)oomph::SegregatableFSIProbleminline
assess_convergence_based_on_max_global_residual()oomph::SegregatableFSIProbleminline
Assess_convergence_based_on_relative_solid_change enum valueoomph::SegregatableFSIProblem
assess_convergence_based_on_relative_solid_change(const double &tol)oomph::SegregatableFSIProbleminline
assess_convergence_based_on_relative_solid_change()oomph::SegregatableFSIProbleminline
assign_eigenvector_to_dofs(DoubleVector &eigenvector)oomph::Problem
assign_eqn_numbers(const bool &assign_local_eqn_numbers=true)oomph::Problem
assign_initial_values_impulsive()oomph::Problem
assign_initial_values_impulsive(const double &dt)oomph::Problem
Base_mesh_element_number_plus_oneoomph::Problemprivate
Base_mesh_element_ptoomph::Problemprivate
bifurcation_adapt_doc_errors(const unsigned &bifurcation_type)oomph::Problemprivate
bifurcation_adapt_helper(unsigned &n_refined, unsigned &n_unrefined, const unsigned &bifurcation_type, const bool &actually_adapt=true)oomph::Problemprivate
Bifurcation_detectionoomph::Problemprotected
bifurcation_parameter_pt() constoomph::Problem
Bisect_to_find_bifurcationoomph::Problemprotected
build_global_mesh()oomph::Problem
build_mesh()oomph::Probleminlinevirtual
Bypass_increase_in_dof_check_during_pruningoomph::Problemprotected
calculate_continuation_derivatives(double *const &parameter_pt)oomph::Problemprotected
calculate_continuation_derivatives(const DoubleVector &z)oomph::Problemprotected
calculate_continuation_derivatives_fd(double *const &parameter_pt)oomph::Problemprotected
calculate_continuation_derivatives_fd_helper(double *const &parameter_pt)oomph::Problemprivate
calculate_continuation_derivatives_helper(const DoubleVector &z)oomph::Problemprivate
Calculate_dparameter_analyticoomph::Problemprotected
Calculate_hessian_products_analyticoomph::Problemprotected
calculate_predictions()oomph::Problem
check_halo_schemes(DocInfo &doc_info)oomph::Problem
check_halo_schemes()oomph::Probleminline
clear_elemental_assembly_time()oomph::Probleminline
Communicator_ptoomph::Problemprotected
communicator_pt()oomph::Probleminline
communicator_pt() constoomph::Probleminline
Continuation_directionoomph::Problemprotected
Continuation_time_stepperoomph::Problemprotectedstatic
convergence_criteria enum nameoomph::SegregatableFSIProblem
Convergence_criterionoomph::SegregatableFSIProblemprivate
Convergence_toleranceoomph::SegregatableFSIProblemprotected
copy(Problem *orig_problem_pt)oomph::Problem
copy_haloed_eqn_numbers_helper(const bool &do_halos, const bool &do_external_halos)oomph::Problemprivate
Copy_of_problem_ptoomph::Problemprotected
create_new_linear_algebra_distribution(LinearAlgebraDistribution *&dist_pt)oomph::Problem
deactivate_bifurcation_tracking()oomph::Probleminline
debug_hook_fct(const unsigned &i)oomph::Probleminlinevirtual
Default_assembly_handler_ptoomph::Problemprivate
Default_eigen_solver_ptoomph::Problemprivate
Default_linear_solver_ptoomph::Problemprivate
Default_matrix_distribution enum valueoomph::Problem
Default_set_initial_condition_calledoomph::Problemprivate
Del_irons_and_tuckoomph::SegregatableFSIProblemprotected
delete_all_external_storage()oomph::Problem
describe_dofs(std::ostream &out= *(oomph_info.stream_pt())) constoomph::Problem
Desired_newton_iterations_dsoomph::Problemprotected
Desired_proportion_of_arc_lengthoomph::Problemprotected
disable_discontinuous_formulation()oomph::Probleminline
disable_doc_imbalance_in_parallel_assembly()oomph::Probleminline
disable_globally_convergent_newton_method()oomph::Probleminline
disable_info_in_newton_solve()oomph::Probleminline
disable_irons_and_tuck_extrapolation()oomph::SegregatableFSIProbleminline
disable_jacobian_reuse()oomph::Probleminline
disable_mass_matrix_reuse()oomph::Problem
disable_pointwise_aitken()oomph::SegregatableFSIProbleminline
disable_problem_distributed()oomph::Probleminline
disable_store_local_dof_pt_in_elements()oomph::Probleminline
Discontinuous_element_formulationoomph::Problemprotected
Dist_problem_matrix_distributionoomph::Problemprivate
distribute(const Vector< unsigned > &element_partition, DocInfo &doc_info, const bool &report_stats=false)oomph::Problem
distribute(DocInfo &doc_info, const bool &report_stats=false)oomph::Problem
distribute(const Vector< unsigned > &element_partition, const bool &report_stats=false)oomph::Problem
distribute(const bool &report_stats=false)oomph::Problem
distributed() constoomph::Probleminline
Distributed_problem_matrix_distribution enum nameoomph::Problem
distributed_problem_matrix_distribution()oomph::Probleminline
doc_errors(DocInfo &doc_info)oomph::Problem
doc_errors()oomph::Probleminline
Doc_imbalance_in_parallel_assemblyoomph::Problemprivate
Doc_max_global_residualoomph::SegregatableFSIProblemprotected
Doc_time_in_distributeoomph::Problemprotected
does_pointer_correspond_to_problem_data(double *const &parameter_pt)oomph::Problemprotected
dof(const unsigned &i)oomph::Probleminline
dof(const unsigned &i) constoomph::Probleminline
dof_current(const unsigned &i)oomph::Probleminlineprotected
Dof_currentoomph::Problemprotected
Dof_current_offsetoomph::Problemprotected
dof_derivative(const unsigned &i)oomph::Probleminlineprotected
Dof_derivativeoomph::Problemprotected
Dof_derivative_offsetoomph::Problemprotected
dof_distribution_pt() constoomph::Probleminline
Dof_distribution_ptoomph::Problemprotected
dof_pt(const unsigned &i)oomph::Probleminline
dof_pt(const unsigned &i) constoomph::Probleminline
Dof_ptoomph::Problemprotected
doubly_adaptive_unsteady_newton_solve(const double &dt, const double &epsilon, const unsigned &max_adapt, const bool &first, const bool &shift=true)oomph::Probleminline
doubly_adaptive_unsteady_newton_solve(const double &dt, const double &epsilon, const unsigned &max_adapt, const unsigned &suppress_resolve_after_spatial_adapt_flag, const bool &first, const bool &shift=true)oomph::Probleminline
doubly_adaptive_unsteady_newton_solve_helper(const double &dt, const double &epsilon, const unsigned &max_adapt, const unsigned &suppress_resolve_after_spatial_adapt, const bool &first, const bool &shift=true)oomph::Problemprivate
Ds_currentoomph::Problemprotected
DTSF_max_increaseoomph::Problemprotected
DTSF_min_decreaseoomph::Problemprotected
Dummy_time_valueoomph::ExplicitTimeSteppableObjectprivatestatic
dump(std::ofstream &dump_file) constoomph::Problemvirtual
dump(const std::string &dump_file_name) constoomph::Probleminline
eigen_solver_pt()oomph::Probleminline
eigen_solver_pt() constoomph::Probleminline
Eigen_solver_ptoomph::Problemprivate
Element_count_per_dofoomph::Problemprotected
Elemental_assembly_timeoomph::Problemprotected
elemental_assembly_time()oomph::Probleminline
Empty_actions_after_read_unstructured_meshes_has_been_calledoomph::Problemprivate
Empty_actions_before_read_unstructured_meshes_has_been_calledoomph::Problemprivate
enable_discontinuous_formulation()oomph::Probleminline
enable_doc_imbalance_in_parallel_assembly()oomph::Probleminline
enable_globally_convergent_newton_method()oomph::Probleminline
enable_info_in_newton_solve()oomph::Probleminline
enable_irons_and_tuck_extrapolation()oomph::SegregatableFSIProbleminline
enable_jacobian_reuse()oomph::Probleminline
enable_mass_matrix_reuse()oomph::Problem
enable_pointwise_aitken(const unsigned &pointwise_aitken_start)oomph::SegregatableFSIProbleminline
enable_pointwise_aitken()oomph::SegregatableFSIProbleminline
enable_problem_distributed()oomph::Probleminline
enable_store_local_dof_pt_in_elements()oomph::Probleminline
enable_under_relaxation(const double &omega=1.0)oomph::SegregatableFSIProbleminline
Explicit_time_stepper_ptoomph::Problemprivate
explicit_time_stepper_pt()oomph::Probleminline
explicit_timestep(const double &dt, const bool &shift_values=true)oomph::Problem
ExplicitTimeSteppableObject()oomph::ExplicitTimeSteppableObjectinline
ExplicitTimeSteppableObject(const ExplicitTimeSteppableObject &)=deleteoomph::ExplicitTimeSteppableObject
extrapolate_solid_data()oomph::SegregatableFSIProblemprivate
FD_step_used_in_get_hessian_vector_productsoomph::Problemprotected
First_el_for_assemblyoomph::Problemprivate
First_jacobian_sign_changeoomph::Problemprotected
Fluid_data_ptoomph::SegregatableFSIProblemprotected
Fluid_mesh_ptoomph::SegregatableFSIProblemprotected
Fluid_solve enum valueoomph::SegregatableFSIProblem
Fluid_value_is_pinnedoomph::SegregatableFSIProblemprotected
flush_global_data()oomph::Probleminline
flush_sub_meshes()oomph::Probleminline
Full_solve enum valueoomph::SegregatableFSIProblem
get_all_error_estimates(Vector< Vector< double >> &elemental_error)oomph::Problem
get_all_halo_data(std::map< unsigned, double * > &map_of_halo_data)oomph::Problem
get_bifurcation_eigenfunction(Vector< DoubleVector > &eigenfunction)oomph::Problem
get_data_to_be_sent_during_load_balancing(const Vector< unsigned > &element_domain_on_this_proc, Vector< int > &send_n, Vector< double > &send_data, Vector< int > &send_displacement, Vector< unsigned > &old_domain_for_base_element, Vector< unsigned > &new_domain_for_base_element, unsigned &max_refinement_level_overall)oomph::Problemprivate
get_derivative_wrt_global_parameter(double *const &parameter_pt, DoubleVector &result)oomph::Problem
get_dofs(DoubleVector &dofs) constoomph::Problemvirtual
get_dofs(const unsigned &t, DoubleVector &dofs) constoomph::Problemvirtual
get_dvaluesdt(DoubleVector &f)oomph::Problemvirtual
get_eigenproblem_matrices(CRDoubleMatrix &mass_matrix, CRDoubleMatrix &main_matrix, const double &shift=0.0)oomph::Problemvirtual
get_fd_jacobian(DoubleVector &residuals, DenseMatrix< double > &jacobian)oomph::Problem
get_first_and_last_element_for_assembly(Vector< unsigned > &first_el_for_assembly, Vector< unsigned > &last_el_for_assembly) constoomph::Probleminline
get_flat_packed_refinement_pattern_for_load_balancing(const Vector< unsigned > &old_domain_for_base_element, const Vector< unsigned > &new_domain_for_base_element, const unsigned &max_refinement_level_overall, std::map< unsigned, Vector< unsigned >> &flat_packed_refinement_info_for_root)oomph::Problemprivate
get_hessian_vector_products(DoubleVectorWithHaloEntries const &Y, Vector< DoubleVectorWithHaloEntries > const &C, Vector< DoubleVectorWithHaloEntries > &product)oomph::Problem
get_inverse_mass_matrix_times_residuals(DoubleVector &Mres)oomph::Problemvirtual
get_jacobian(DoubleVector &residuals, DenseDoubleMatrix &jacobian)oomph::Problemvirtual
get_jacobian(DoubleVector &residuals, CRDoubleMatrix &jacobian)oomph::Problemvirtual
get_jacobian(DoubleVector &residuals, CCDoubleMatrix &jacobian)oomph::Problemvirtual
get_jacobian(DoubleVector &residuals, SumOfMatrices &jacobian)oomph::Probleminlinevirtual
get_my_eqns(AssemblyHandler *const &assembly_handler_pt, const unsigned &el_lo, const unsigned &el_hi, Vector< unsigned > &my_eqns)oomph::Problemprivate
get_residuals(DoubleVector &residuals)oomph::Problemvirtual
get_solid_change(double &rms_change, double &max_change, double &rms_norm)oomph::SegregatableFSIProblem
global_data_pt(const unsigned &i)oomph::Probleminline
Global_data_ptoomph::Problemprivate
global_dof_pt(const unsigned &i)oomph::Probleminline
global_temporal_error_norm()oomph::Probleminlineprotectedvirtual
globally_convergent_line_search(const Vector< double > &x_old, const double &half_residual_squared_old, DoubleVector &gradient, DoubleVector &newton_dir, double &half_residual_squared, const double &stpmax)oomph::Problemprivate
Halo_dof_ptoomph::Problemprotected
Halo_scheme_ptoomph::Problemprotected
halt_timer()oomph::SegregatableFSIProbleminline
identify_fluid_and_solid_dofs(Vector< Data * > &fluid_data_pt, Vector< Data * > &solid_data_pt, Mesh *&fluid_mesh_pt, Mesh *&solid_mesh_pt)=0oomph::SegregatableFSIProblempure virtual
initialise_dt(const double &dt)oomph::Problem
initialise_dt(const Vector< double > &dt)oomph::Problem
is_dparameter_calculated_analytically(double *const &parameter_pt)oomph::Probleminline
Jacobian_has_been_computedoomph::Problemprotected
jacobian_reuse_is_enabled()oomph::Probleminline
Jacobian_reuse_is_enabledoomph::Problemprotected
Keep_temporal_error_below_toleranceoomph::Problemprotected
Last_el_plus_one_for_assemblyoomph::Problemprivate
linear_solver_pt()oomph::Probleminline
linear_solver_pt() constoomph::Probleminline
Linear_solver_ptoomph::Problemprivate
load_balance()oomph::Probleminline
load_balance(const bool &report_stats)oomph::Probleminline
load_balance(DocInfo &doc_info, const bool &report_stats)oomph::Probleminline
load_balance(DocInfo &doc_info, const bool &report_stats, const Vector< unsigned > &input_target_domain_for_local_non_halo_element)oomph::Problem
make_copy()oomph::Problemvirtual
Mass_matrix_has_been_computedoomph::Problemprotected
Mass_matrix_reuse_is_enabledoomph::Problemprotected
mass_matrix_reuse_is_enabled()oomph::Probleminline
Mass_matrix_solver_for_explicit_timestepper_ptoomph::Problemprivate
mass_matrix_solver_for_explicit_timestepper_pt()oomph::Probleminline
mass_matrix_solver_for_explicit_timestepper_pt() constoomph::Probleminline
max_newton_iterations()oomph::Probleminline
Max_newton_iterationsoomph::Problemprotected
Max_permitted_error_for_halo_checkoomph::Problem
Max_picardoomph::SegregatableFSIProblemprotected
Max_resoomph::Problemprotected
max_residuals()oomph::Probleminline
Max_residualsoomph::Problemprotected
Maximum_dtoomph::Problemprotected
maximum_dt()oomph::Probleminline
Mesh_ptoomph::Problemprivate
mesh_pt()oomph::Probleminline
mesh_pt() constoomph::Probleminline
mesh_pt(const unsigned &imesh)oomph::Probleminline
mesh_pt(const unsigned &imesh) constoomph::Probleminline
Minimum_dsoomph::Problemprotected
minimum_dt()oomph::Probleminline
Minimum_dtoomph::Problemprotected
Minimum_dt_but_still_proceedoomph::Problemprotected
Must_recompute_load_balance_for_assemblyoomph::Problemprivate
ndof() constoomph::Probleminline
newton_solve()oomph::Problem
newton_solve(unsigned const &max_adapt)oomph::Problem
newton_solve_continuation(double *const &parameter_pt)oomph::Problemprotected
newton_solve_continuation(double *const &parameter_pt, DoubleVector &z)oomph::Problemprotected
Newton_solver_toleranceoomph::Problemprotected
newton_solver_tolerance()oomph::Probleminline
nglobal_data() constoomph::Probleminline
Nnewton_iter_takenoomph::Problemprotected
nsub_mesh() constoomph::Probleminline
ntime_stepper() constoomph::Probleminline
Numerical_zero_for_sparse_assemblyoomph::Problemprotected
Omega_relaxoomph::SegregatableFSIProblemprivate
operator=(const Problem &)=deleteoomph::Problem
oomph::ExplicitTimeSteppableObject::operator=(const ExplicitTimeSteppableObject &)=deleteoomph::ExplicitTimeSteppableObject
Orig_sub_mesh_ptoomph::SegregatableFSIProblemprotected
p_adapt(unsigned &n_refined, unsigned &n_unrefined)oomph::Problem
p_adapt()oomph::Probleminline
p_refine_selected_elements(const Vector< unsigned > &elements_to_be_refined)oomph::Problem
p_refine_selected_elements(const Vector< PRefineableElement * > &elements_to_be_refined_pt)oomph::Problem
p_refine_selected_elements(const unsigned &i_mesh, const Vector< unsigned > &elements_to_be_refined)oomph::Problem
p_refine_selected_elements(const unsigned &i_mesh, const Vector< PRefineableElement * > &elements_to_be_refined_pt)oomph::Problem
p_refine_selected_elements(const Vector< Vector< unsigned >> &elements_to_be_refined)oomph::Problem
p_refine_selected_elements(const Vector< Vector< PRefineableElement * >> &elements_to_be_refined_pt)oomph::Problem
p_refine_uniformly(const Vector< unsigned > &nrefine_for_mesh)oomph::Probleminline
p_refine_uniformly(const Vector< unsigned > &nrefine_for_mesh, DocInfo &doc_info)oomph::Probleminline
p_refine_uniformly(DocInfo &doc_info)oomph::Probleminline
p_refine_uniformly()oomph::Probleminline
p_refine_uniformly(const unsigned &i_mesh, DocInfo &doc_info)oomph::Problem
p_refine_uniformly(const unsigned &i_mesh)oomph::Probleminline
p_refine_uniformly_and_prune(const Vector< unsigned > &nrefine_for_mesh)oomph::Probleminline
p_refine_uniformly_and_prune(const Vector< unsigned > &nrefine_for_mesh, DocInfo &doc_info)oomph::Probleminline
p_refine_uniformly_and_prune(DocInfo &doc_info)oomph::Probleminline
p_refine_uniformly_aux(const Vector< unsigned > &nrefine_for_mesh, DocInfo &doc_info, const bool &prune)oomph::Problemprivate
p_unrefine_uniformly(DocInfo &doc_info)oomph::Problem
p_unrefine_uniformly(const unsigned &i_mesh, DocInfo &doc_info)oomph::Problem
parallel_sparse_assemble(const LinearAlgebraDistribution *const &dist_pt, Vector< int * > &column_or_row_index, Vector< int * > &row_or_column_start, Vector< double * > &value, Vector< unsigned > &nnz, Vector< double * > &residuals)oomph::Problemprivate
Parallel_sparse_assemble_previous_allocationoomph::Problemprivate
Parameter_currentoomph::Problemprotected
Parameter_derivativeoomph::Problemprotected
partition_global_mesh(Mesh *&global_mesh_pt, DocInfo &doc_info, Vector< unsigned > &element_domain, const bool &report_stats=false)oomph::Problemvirtual
Pause_at_end_of_sparse_assemblyoomph::Problemprotected
Perform_assembly_using_lists enum valueoomph::Problemprotected
Perform_assembly_using_maps enum valueoomph::Problemprotected
Perform_assembly_using_two_arrays enum valueoomph::Problemprotected
Perform_assembly_using_two_vectors enum valueoomph::Problemprotected
Perform_assembly_using_vectors_of_pairs enum valueoomph::Problemprotected
pin_fluid_dofs()oomph::SegregatableFSIProblemprivate
pin_solid_dofs()oomph::SegregatableFSIProblemprotected
Pointwise_aitken_counteroomph::SegregatableFSIProblemprotected
pointwise_aitken_extrapolate()oomph::SegregatableFSIProblemprotected
Pointwise_aitken_solid_valueoomph::SegregatableFSIProblemprotected
Pointwise_aitken_startoomph::SegregatableFSIProblemprotected
Previous_solid_valueoomph::SegregatableFSIProblemprotected
Problem()oomph::Problem
Problem(const Problem &dummy)=deleteoomph::Problem
problem_has_been_distributed()oomph::Probleminline
Problem_has_been_distributedoomph::Problemprotected
problem_is_nonlinear(const bool &prob_lin)oomph::Probleminline
Problem_is_nonlinearoomph::Problemprotected
Problem_matrix_distribution enum valueoomph::Problem
prune_halo_elements_and_nodes(DocInfo &doc_info, const bool &report_stats)oomph::Problem
prune_halo_elements_and_nodes(const bool &report_stats=false)oomph::Probleminline
R_irons_and_tuckoomph::SegregatableFSIProblemprotected
read(std::ifstream &restart_file, bool &unsteady_restart)oomph::Problemvirtual
read(std::ifstream &restart_file)oomph::Probleminlinevirtual
rebuild_global_mesh()oomph::Problem
rebuild_monolithic_mesh()oomph::SegregatableFSIProblemprotected
Recheck_convergence_after_pointwise_aitkenoomph::SegregatableFSIProblemprotected
recompute_load_balanced_assembly()oomph::Problemprivate
refine_distributed_base_mesh(Vector< Vector< Vector< unsigned >>> &to_be_refined_on_each_root, const unsigned &max_level_overall)oomph::Problem
refine_selected_elements(const Vector< unsigned > &elements_to_be_refined)oomph::Problem
refine_selected_elements(const Vector< RefineableElement * > &elements_to_be_refined_pt)oomph::Problem
refine_selected_elements(const unsigned &i_mesh, const Vector< unsigned > &elements_to_be_refined)oomph::Problem
refine_selected_elements(const unsigned &i_mesh, const Vector< RefineableElement * > &elements_to_be_refined_pt)oomph::Problem
refine_selected_elements(const Vector< Vector< unsigned >> &elements_to_be_refined)oomph::Problem
refine_selected_elements(const Vector< Vector< RefineableElement * >> &elements_to_be_refined_pt)oomph::Problem
refine_uniformly(const Vector< unsigned > &nrefine_for_mesh)oomph::Probleminline
refine_uniformly(const Vector< unsigned > &nrefine_for_mesh, DocInfo &doc_info)oomph::Probleminline
refine_uniformly(DocInfo &doc_info)oomph::Probleminline
refine_uniformly()oomph::Probleminline
refine_uniformly(const unsigned &i_mesh, DocInfo &doc_info)oomph::Problem
refine_uniformly(const unsigned &i_mesh)oomph::Probleminline
refine_uniformly_and_prune(const Vector< unsigned > &nrefine_for_mesh)oomph::Probleminline
refine_uniformly_and_prune(const Vector< unsigned > &nrefine_for_mesh, DocInfo &doc_info)oomph::Probleminline
refine_uniformly_and_prune(DocInfo &doc_info)oomph::Probleminline
refine_uniformly_aux(const Vector< unsigned > &nrefine_for_mesh, DocInfo &doc_info, const bool &prune)oomph::Problemprivate
Relaxation_factoroomph::Problemprotected
remove_duplicate_data(Mesh *const &mesh_pt, bool &actually_removed_some_data)oomph::Problemprivate
remove_null_pointers_from_external_halo_node_storage()oomph::Problemprivate
reset_arc_length_parameters()oomph::Probleminline
reset_assembly_handler_to_default()oomph::Problem
reset_timer()oomph::SegregatableFSIProbleminline
restart_timer()oomph::SegregatableFSIProbleminline
restore_dof_values()oomph::Problem
restore_fluid_dofs()oomph::SegregatableFSIProblemprotected
restore_solid_dofs()oomph::SegregatableFSIProblemprotected
Saved_dof_ptoomph::Problemprivate
Scale_arc_lengthoomph::Problemprotected
SegregatableFSIProblem()oomph::SegregatableFSIProbleminline
segregated_solve()oomph::SegregatableFSIProblem
self_test()oomph::Problem
send_data_to_be_sent_during_load_balancing(Vector< int > &send_n, Vector< double > &send_data, Vector< int > &send_displacement)oomph::Problemprivate
send_refinement_info_helper(Vector< unsigned > &old_domain_for_base_element, Vector< unsigned > &new_domain_for_base_element, const unsigned &max_refinement_level_overall, std::map< unsigned, Vector< unsigned >> &refinement_info_for_root_local, Vector< Vector< Vector< unsigned >>> &refinement_info_for_root_elements)oomph::Problemprivate
set_analytic_dparameter(double *const &parameter_pt)oomph::Probleminline
set_analytic_hessian_products()oomph::Probleminline
set_consistent_pinned_values_for_continuation()oomph::Problemprotected
set_default_first_and_last_element_for_assembly()oomph::Problem
set_default_partition_in_load_balance()oomph::Probleminline
set_dofs(const DoubleVector &dofs)oomph::Problemvirtual
set_dofs(const unsigned &t, DoubleVector &dofs)oomph::Problem
set_dofs(const unsigned &t, Vector< double * > &dof_pt)oomph::Problem
set_explicit_time_stepper_pt(ExplicitTimeStepper *const &explicit_time_stepper_pt)oomph::Problem
set_first_and_last_element_for_assembly(Vector< unsigned > &first_el_for_assembly, Vector< unsigned > &last_el_for_assembly)oomph::Probleminline
set_initial_condition()oomph::Probleminlineprotectedvirtual
set_pinned_values_to_zero()oomph::Problem
set_timestepper_for_all_data(TimeStepper *const &time_stepper_pt, const bool &preserve_existing_data=false)oomph::Problem
setup_base_mesh_info_after_pruning()oomph::Problemprivate
setup_dof_halo_scheme()oomph::Problemprotected
setup_element_count_per_dof()oomph::Problemprotected
setup_segregated_solver(const bool &full_setup_of_fluid_and_solid_dofs=true)oomph::SegregatableFSIProblem
shift_time_values()oomph::Problemvirtual
Shut_up_in_newton_solveoomph::Problem
Sign_of_jacobianoomph::Problemprotected
sign_of_jacobian()oomph::Probleminline
Solid_data_ptoomph::SegregatableFSIProblemprotected
Solid_mesh_ptoomph::SegregatableFSIProblemprotected
Solid_solve enum valueoomph::SegregatableFSIProblem
Solid_value_is_pinnedoomph::SegregatableFSIProblemprotected
solve_adjoint_eigenproblem(const unsigned &n_eval, Vector< std::complex< double >> &eigenvalue, Vector< DoubleVector > &eigenvector_real, Vector< DoubleVector > &eigenvector_imag, const bool &steady=true)oomph::Problem
solve_adjoint_eigenproblem(const unsigned &n_eval, Vector< std::complex< double >> &eigenvalue, const bool &steady=true)oomph::Probleminline
solve_adjoint_eigenproblem_legacy(const unsigned &n_eval, Vector< std::complex< double >> &eigenvalue, Vector< DoubleVector > &eigenvector, const bool &make_timesteppers_steady=true)oomph::Problem
solve_eigenproblem(const unsigned &n_eval, Vector< std::complex< double >> &alpha, Vector< double > &beta, Vector< DoubleVector > &eigenvector_real, Vector< DoubleVector > &eigenvector_imag, const bool &steady=true)oomph::Problem
solve_eigenproblem(const unsigned &n_eval, Vector< std::complex< double >> &eigenvalue, Vector< DoubleVector > &eigenvector_real, Vector< DoubleVector > &eigenvector_imag, const bool &steady=true)oomph::Problem
solve_eigenproblem(const unsigned &n_eval, Vector< std::complex< double >> &eigenvalue, const bool &make_timesteppers_steady=true)oomph::Probleminline
solve_eigenproblem(const unsigned &n_eval, Vector< std::complex< double >> &alpha, Vector< double > &beta, const bool &steady=true)oomph::Probleminline
solve_eigenproblem_legacy(const unsigned &n_eval, Vector< std::complex< double >> &eigenvalue, Vector< DoubleVector > &eigenvector, const bool &steady=true)oomph::Problem
solve_eigenproblem_legacy(const unsigned &n_eval, Vector< std::complex< double >> &eigenvalue, const bool &steady=true)oomph::Probleminline
solve_type enum nameoomph::SegregatableFSIProblem
Solve_typeoomph::SegregatableFSIProblemprotected
sparse_assemble_row_or_column_compressed(Vector< int * > &column_or_row_index, Vector< int * > &row_or_column_start, Vector< double * > &value, Vector< unsigned > &nnz, Vector< double * > &residual, bool compressed_row_flag)oomph::Problemprotectedvirtual
sparse_assemble_row_or_column_compressed_with_lists(Vector< int * > &column_or_row_index, Vector< int * > &row_or_column_start, Vector< double * > &value, Vector< unsigned > &nnz, Vector< double * > &residual, bool compressed_row_flag)oomph::Problemprivatevirtual
sparse_assemble_row_or_column_compressed_with_maps(Vector< int * > &column_or_row_index, Vector< int * > &row_or_column_start, Vector< double * > &value, Vector< unsigned > &nnz, Vector< double * > &residual, bool compressed_row_flag)oomph::Problemprivatevirtual
sparse_assemble_row_or_column_compressed_with_two_arrays(Vector< int * > &column_or_row_index, Vector< int * > &row_or_column_start, Vector< double * > &value, Vector< unsigned > &nnz, Vector< double * > &residual, bool compressed_row_flag)oomph::Problemprivatevirtual
sparse_assemble_row_or_column_compressed_with_two_vectors(Vector< int * > &column_or_row_index, Vector< int * > &row_or_column_start, Vector< double * > &value, Vector< unsigned > &nnz, Vector< double * > &residual, bool compressed_row_flag)oomph::Problemprivatevirtual
sparse_assemble_row_or_column_compressed_with_vectors_of_pairs(Vector< int * > &column_or_row_index, Vector< int * > &row_or_column_start, Vector< double * > &value, Vector< unsigned > &nnz, Vector< double * > &residual, bool compressed_row_flag)oomph::Problemprivatevirtual
Sparse_assemble_with_arrays_allocation_incrementoomph::Problemprotected
Sparse_assemble_with_arrays_initial_allocationoomph::Problemprotected
Sparse_assemble_with_arrays_previous_allocationoomph::Problemprotected
Sparse_assembly_methodoomph::Problemprotected
SpatialErrorEstimatorFctPt typedefoomph::Problem
SpatialErrorEstimatorWithDocFctPt typedefoomph::Problem
steady_newton_solve(unsigned const &max_adapt=0)oomph::Problem
steady_segregated_solve()oomph::SegregatableFSIProblem
store_current_dof_values()oomph::Problem
Store_local_dof_pt_in_elementsoomph::Problemprivate
store_solid_dofs()oomph::SegregatableFSIProblem
Sub_mesh_ptoomph::Problemprivate
Suppress_warning_about_actions_before_read_unstructured_meshesoomph::Problemstatic
symmetrise_eigenfunction_for_adaptive_pitchfork_tracking()oomph::Problemvirtual
synchronise_all_dofs()oomph::Problem
synchronise_dofs(const bool &do_halos, const bool &do_external_halos)oomph::Problem
synchronise_eqn_numbers(const bool &assign_local_eqn_numbers=true)oomph::Problem
T_refoomph::SegregatableFSIProblemprivate
T_spent_on_actual_solveoomph::SegregatableFSIProblemprivate
t_spent_on_actual_solve()oomph::SegregatableFSIProbleminline
Theta_squaredoomph::Problemprotected
time()oomph::Problemvirtual
time() constoomph::Problem
time_adaptive_newton_crash_on_solve_fail()oomph::Probleminline
Time_adaptive_newton_crash_on_solve_failoomph::Problemprotected
time_pt()oomph::Probleminline
time_pt() constoomph::Probleminlinevirtual
Time_ptoomph::Problemprivate
Time_stepper_ptoomph::Problemprivate
time_stepper_pt()oomph::Probleminline
time_stepper_pt() constoomph::Probleminline
time_stepper_pt(const unsigned &i)oomph::Probleminline
Timer_has_been_haltedoomph::SegregatableFSIProblemprivate
Timestep_reduction_factor_after_nonconvergenceoomph::Problemprotected
under_relax_solid()oomph::SegregatableFSIProblemprivate
Uniform_matrix_distribution enum valueoomph::Problem
unrefine_uniformly()oomph::Problem
unrefine_uniformly(const unsigned &i_mesh)oomph::Problem
unset_analytic_dparameter(double *const &parameter_pt)oomph::Probleminline
unset_analytic_hessian_products()oomph::Probleminline
unset_default_partition_in_load_balance()oomph::Probleminline
unsteady_newton_solve(const double &dt)oomph::Problem
unsteady_newton_solve(const double &dt, const bool &shift_values)oomph::Problem
unsteady_newton_solve(const double &dt, const unsigned &max_adapt, const bool &first, const bool &shift=true)oomph::Problem
unsteady_segregated_solve(const double &dt)oomph::SegregatableFSIProblem
unsteady_segregated_solve(const double &dt, const bool &shift_values)oomph::SegregatableFSIProblem
Use_continuation_timestepperoomph::Problemprotected
Use_default_partition_in_load_balanceoomph::Problemprivate
Use_finite_differences_for_continuation_derivativesoomph::Problemprotected
Use_globally_convergent_newton_methodoomph::Problemprivate
Use_irons_and_tuck_extrapolationoomph::SegregatableFSIProblemprivate
use_only_fluid_elements()oomph::SegregatableFSIProblemprivate
use_only_solid_elements()oomph::SegregatableFSIProblemprivate
Use_pointwise_aitkenoomph::SegregatableFSIProblemprotected
Use_predictor_values_as_initial_guessoomph::Problemprivate
use_predictor_values_as_initial_guess()oomph::Probleminline
~ExplicitTimeSteppableObject()oomph::ExplicitTimeSteppableObjectinlinevirtual
~Problem()oomph::Problemvirtual
~SegregatableFSIProblem()oomph::SegregatableFSIProbleminlinevirtual