actions_after_adapt() | oomph::Problem | inlinevirtual |
actions_after_change_in_bifurcation_parameter() | oomph::Problem | inlineprotectedvirtual |
actions_after_change_in_global_parameter(double *const ¶meter_pt) | oomph::Problem | inlineprotectedvirtual |
actions_after_distribute() | oomph::Problem | inlineprotectedvirtual |
actions_after_explicit_stage() | oomph::ExplicitTimeSteppableObject | inlinevirtual |
actions_after_explicit_timestep() | oomph::Problem | inlineprotectedvirtual |
actions_after_implicit_timestep() | oomph::Problem | inlineprotectedvirtual |
actions_after_implicit_timestep_and_error_estimation() | oomph::Problem | inlineprotectedvirtual |
actions_after_newton_solve() | oomph::Problem | inlineprotectedvirtual |
actions_after_newton_step() | oomph::Problem | inlineprotectedvirtual |
actions_after_parameter_increase(double *const ¶meter_pt) | oomph::Problem | inlineprotectedvirtual |
actions_after_read_unstructured_meshes() | oomph::Problem | inlineprotectedvirtual |
actions_before_adapt() | oomph::Problem | inlinevirtual |
actions_before_distribute() | oomph::Problem | inlineprotectedvirtual |
actions_before_explicit_stage() | oomph::ExplicitTimeSteppableObject | inlinevirtual |
actions_before_explicit_timestep() | oomph::Problem | inlineprotectedvirtual |
actions_before_implicit_timestep() | oomph::Problem | inlineprotectedvirtual |
actions_before_newton_convergence_check() | oomph::Problem | inlineprotectedvirtual |
actions_before_newton_solve() | oomph::Problem | inlineprotectedvirtual |
actions_before_newton_step() | oomph::Problem | inlineprotectedvirtual |
actions_before_read_unstructured_meshes() | oomph::Problem | inlineprotectedvirtual |
activate_bifurcation_tracking(double *const ¶meter_pt, const DoubleVector &eigenvector, const bool &block_solve=true) | oomph::Problem | |
activate_bifurcation_tracking(double *const ¶meter_pt, const DoubleVector &eigenvector, const DoubleVector &normalisation, const bool &block_solve=true) | oomph::Problem | |
activate_fold_tracking(double *const ¶meter_pt, const bool &block_solve=true) | oomph::Problem | |
activate_hopf_tracking(double *const ¶meter_pt, const bool &block_solve=true) | oomph::Problem | |
activate_hopf_tracking(double *const ¶meter_pt, const double &omega, const DoubleVector &null_real, const DoubleVector &null_imag, const bool &block_solve=true) | oomph::Problem | |
activate_pitchfork_tracking(double *const ¶meter_pt, const DoubleVector &symmetry_vector, const bool &block_solve=true) | oomph::Problem | |
adapt(unsigned &n_refined, unsigned &n_unrefined) | oomph::Problem | |
adapt() | oomph::Problem | inline |
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::Problem | inline |
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::Problem | inline |
add_sub_mesh(Mesh *const &mesh_pt) | oomph::Problem | inline |
add_time_stepper_pt(TimeStepper *const &time_stepper_pt) | oomph::Problem | |
add_to_dofs(const double &lambda, const DoubleVector &increment_dofs) | oomph::Problem | virtual |
Always_take_one_newton_step | oomph::Problem | protected |
arc_length_step_solve(double *const ¶meter_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 ¶meter_pt, const double &ds, const unsigned &max_adapt) | oomph::Problem | private |
Arc_length_step_taken | oomph::Problem | protected |
are_hessian_products_calculated_analytically() | oomph::Problem | inline |
assembly_handler_pt() | oomph::Problem | inline |
assembly_handler_pt() const | oomph::Problem | inline |
Assembly_handler_pt | oomph::Problem | private |
Assembly_method enum name | oomph::Problem | protected |
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_one | oomph::Problem | private |
Base_mesh_element_pt | oomph::Problem | private |
bifurcation_adapt_doc_errors(const unsigned &bifurcation_type) | oomph::Problem | private |
bifurcation_adapt_helper(unsigned &n_refined, unsigned &n_unrefined, const unsigned &bifurcation_type, const bool &actually_adapt=true) | oomph::Problem | private |
Bifurcation_detection | oomph::Problem | protected |
bifurcation_parameter_pt() const | oomph::Problem | |
Bisect_to_find_bifurcation | oomph::Problem | protected |
build_global_mesh() | oomph::Problem | |
build_mesh() | oomph::Problem | inlinevirtual |
Bypass_increase_in_dof_check_during_pruning | oomph::Problem | protected |
calculate_continuation_derivatives(double *const ¶meter_pt) | oomph::Problem | protected |
calculate_continuation_derivatives(const DoubleVector &z) | oomph::Problem | protected |
calculate_continuation_derivatives_fd(double *const ¶meter_pt) | oomph::Problem | protected |
calculate_continuation_derivatives_fd_helper(double *const ¶meter_pt) | oomph::Problem | private |
calculate_continuation_derivatives_helper(const DoubleVector &z) | oomph::Problem | private |
Calculate_dparameter_analytic | oomph::Problem | protected |
Calculate_hessian_products_analytic | oomph::Problem | protected |
calculate_predictions() | oomph::Problem | |
check_halo_schemes(DocInfo &doc_info) | oomph::Problem | |
check_halo_schemes() | oomph::Problem | inline |
clear_elemental_assembly_time() | oomph::Problem | inline |
communicator_pt() | oomph::Problem | inline |
communicator_pt() const | oomph::Problem | inline |
Communicator_pt | oomph::Problem | protected |
Continuation_direction | oomph::Problem | protected |
Continuation_time_stepper | oomph::Problem | protectedstatic |
copy(Problem *orig_problem_pt) | oomph::Problem | |
copy_haloed_eqn_numbers_helper(const bool &do_halos, const bool &do_external_halos) | oomph::Problem | private |
Copy_of_problem_pt | oomph::Problem | protected |
create_new_linear_algebra_distribution(LinearAlgebraDistribution *&dist_pt) | oomph::Problem | |
deactivate_bifurcation_tracking() | oomph::Problem | inline |
debug_hook_fct(const unsigned &i) | oomph::Problem | inlinevirtual |
Default_assembly_handler_pt | oomph::Problem | private |
Default_eigen_solver_pt | oomph::Problem | private |
Default_linear_solver_pt | oomph::Problem | private |
Default_matrix_distribution enum value | oomph::Problem | |
Default_set_initial_condition_called | oomph::Problem | private |
delete_all_external_storage() | oomph::Problem | |
describe_dofs(std::ostream &out= *(oomph_info.stream_pt())) const | oomph::Problem | |
Desired_newton_iterations_ds | oomph::Problem | protected |
Desired_proportion_of_arc_length | oomph::Problem | protected |
disable_discontinuous_formulation() | oomph::Problem | inline |
disable_doc_imbalance_in_parallel_assembly() | oomph::Problem | inline |
disable_globally_convergent_newton_method() | oomph::Problem | inline |
disable_info_in_newton_solve() | oomph::Problem | inline |
disable_jacobian_reuse() | oomph::Problem | inline |
disable_mass_matrix_reuse() | oomph::Problem | |
disable_problem_distributed() | oomph::Problem | inline |
disable_store_local_dof_pt_in_elements() | oomph::Problem | inline |
Discontinuous_element_formulation | oomph::Problem | protected |
Dist_problem_matrix_distribution | oomph::Problem | private |
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() const | oomph::Problem | inline |
distributed_problem_matrix_distribution() | oomph::Problem | inline |
Distributed_problem_matrix_distribution enum name | oomph::Problem | |
doc_errors(DocInfo &doc_info) | oomph::Problem | |
doc_errors() | oomph::Problem | inline |
Doc_imbalance_in_parallel_assembly | oomph::Problem | private |
Doc_time_in_distribute | oomph::Problem | protected |
does_pointer_correspond_to_problem_data(double *const ¶meter_pt) | oomph::Problem | protected |
dof(const unsigned &i) | oomph::Problem | inline |
dof(const unsigned &i) const | oomph::Problem | inline |
Dof_current | oomph::Problem | protected |
dof_current(const unsigned &i) | oomph::Problem | inlineprotected |
Dof_current_offset | oomph::Problem | protected |
dof_derivative(const unsigned &i) | oomph::Problem | inlineprotected |
Dof_derivative | oomph::Problem | protected |
Dof_derivative_offset | oomph::Problem | protected |
dof_distribution_pt() const | oomph::Problem | inline |
Dof_distribution_pt | oomph::Problem | protected |
Dof_pt | oomph::Problem | protected |
dof_pt(const unsigned &i) | oomph::Problem | inline |
dof_pt(const unsigned &i) const | oomph::Problem | inline |
doubly_adaptive_unsteady_newton_solve(const double &dt, const double &epsilon, const unsigned &max_adapt, const bool &first, const bool &shift=true) | oomph::Problem | inline |
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::Problem | inline |
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::Problem | private |
Ds_current | oomph::Problem | protected |
DTSF_max_increase | oomph::Problem | protected |
DTSF_min_decrease | oomph::Problem | protected |
Dummy_time_value | oomph::ExplicitTimeSteppableObject | privatestatic |
dump(std::ofstream &dump_file) const | oomph::Problem | virtual |
dump(const std::string &dump_file_name) const | oomph::Problem | inline |
eigen_solver_pt() | oomph::Problem | inline |
eigen_solver_pt() const | oomph::Problem | inline |
Eigen_solver_pt | oomph::Problem | private |
Element_count_per_dof | oomph::Problem | protected |
elemental_assembly_time() | oomph::Problem | inline |
Elemental_assembly_time | oomph::Problem | protected |
Empty_actions_after_read_unstructured_meshes_has_been_called | oomph::Problem | private |
Empty_actions_before_read_unstructured_meshes_has_been_called | oomph::Problem | private |
enable_discontinuous_formulation() | oomph::Problem | inline |
enable_doc_imbalance_in_parallel_assembly() | oomph::Problem | inline |
enable_globally_convergent_newton_method() | oomph::Problem | inline |
enable_info_in_newton_solve() | oomph::Problem | inline |
enable_jacobian_reuse() | oomph::Problem | inline |
enable_mass_matrix_reuse() | oomph::Problem | |
enable_problem_distributed() | oomph::Problem | inline |
enable_store_local_dof_pt_in_elements() | oomph::Problem | inline |
explicit_time_stepper_pt() | oomph::Problem | inline |
Explicit_time_stepper_pt | oomph::Problem | private |
explicit_timestep(const double &dt, const bool &shift_values=true) | oomph::Problem | |
ExplicitTimeSteppableObject() | oomph::ExplicitTimeSteppableObject | inline |
ExplicitTimeSteppableObject(const ExplicitTimeSteppableObject &)=delete | oomph::ExplicitTimeSteppableObject | |
FD_step_used_in_get_hessian_vector_products | oomph::Problem | protected |
First_el_for_assembly | oomph::Problem | private |
First_jacobian_sign_change | oomph::Problem | protected |
flush_global_data() | oomph::Problem | inline |
flush_sub_meshes() | oomph::Problem | inline |
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::Problem | private |
get_derivative_wrt_global_parameter(double *const ¶meter_pt, DoubleVector &result) | oomph::Problem | |
get_dofs(DoubleVector &dofs) const | oomph::Problem | virtual |
get_dofs(const unsigned &t, DoubleVector &dofs) const | oomph::Problem | virtual |
get_dvaluesdt(DoubleVector &f) | oomph::Problem | virtual |
get_eigenproblem_matrices(CRDoubleMatrix &mass_matrix, CRDoubleMatrix &main_matrix, const double &shift=0.0) | oomph::Problem | virtual |
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) const | oomph::Problem | inline |
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::Problem | private |
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::Problem | virtual |
get_jacobian(DoubleVector &residuals, DenseDoubleMatrix &jacobian) | oomph::Problem | virtual |
get_jacobian(DoubleVector &residuals, CRDoubleMatrix &jacobian) | oomph::Problem | virtual |
get_jacobian(DoubleVector &residuals, CCDoubleMatrix &jacobian) | oomph::Problem | virtual |
get_jacobian(DoubleVector &residuals, SumOfMatrices &jacobian) | oomph::Problem | inlinevirtual |
get_my_eqns(AssemblyHandler *const &assembly_handler_pt, const unsigned &el_lo, const unsigned &el_hi, Vector< unsigned > &my_eqns) | oomph::Problem | private |
get_residuals(DoubleVector &residuals) | oomph::Problem | virtual |
global_data_pt(const unsigned &i) | oomph::Problem | inline |
Global_data_pt | oomph::Problem | private |
global_dof_pt(const unsigned &i) | oomph::Problem | inline |
global_temporal_error_norm() | oomph::Problem | inlineprotectedvirtual |
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::Problem | private |
Halo_dof_pt | oomph::Problem | protected |
Halo_scheme_pt | oomph::Problem | protected |
HelmholtzMGProblem() | oomph::HelmholtzMGProblem | inline |
initialise_dt(const double &dt) | oomph::Problem | |
initialise_dt(const Vector< double > &dt) | oomph::Problem | |
is_dparameter_calculated_analytically(double *const ¶meter_pt) | oomph::Problem | inline |
Jacobian_has_been_computed | oomph::Problem | protected |
jacobian_reuse_is_enabled() | oomph::Problem | inline |
Jacobian_reuse_is_enabled | oomph::Problem | protected |
Keep_temporal_error_below_tolerance | oomph::Problem | protected |
Last_el_plus_one_for_assembly | oomph::Problem | private |
Linear_solver_pt | oomph::Problem | private |
linear_solver_pt() | oomph::Problem | inline |
linear_solver_pt() const | oomph::Problem | inline |
load_balance() | oomph::Problem | inline |
load_balance(const bool &report_stats) | oomph::Problem | inline |
load_balance(DocInfo &doc_info, const bool &report_stats) | oomph::Problem | inline |
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::Problem | virtual |
make_new_problem()=0 | oomph::HelmholtzMGProblem | pure virtual |
Mass_matrix_has_been_computed | oomph::Problem | protected |
mass_matrix_reuse_is_enabled() | oomph::Problem | inline |
Mass_matrix_reuse_is_enabled | oomph::Problem | protected |
mass_matrix_solver_for_explicit_timestepper_pt() | oomph::Problem | inline |
mass_matrix_solver_for_explicit_timestepper_pt() const | oomph::Problem | inline |
Mass_matrix_solver_for_explicit_timestepper_pt | oomph::Problem | private |
max_newton_iterations() | oomph::Problem | inline |
Max_newton_iterations | oomph::Problem | protected |
Max_permitted_error_for_halo_check | oomph::Problem | |
Max_res | oomph::Problem | protected |
max_residuals() | oomph::Problem | inline |
Max_residuals | oomph::Problem | protected |
Maximum_dt | oomph::Problem | protected |
maximum_dt() | oomph::Problem | inline |
Mesh_pt | oomph::Problem | private |
mesh_pt() | oomph::Problem | inline |
mesh_pt() const | oomph::Problem | inline |
mesh_pt(const unsigned &imesh) | oomph::Problem | inline |
mesh_pt(const unsigned &imesh) const | oomph::Problem | inline |
mg_bulk_mesh_pt()=0 | oomph::HelmholtzMGProblem | pure virtual |
Minimum_ds | oomph::Problem | protected |
Minimum_dt | oomph::Problem | protected |
minimum_dt() | oomph::Problem | inline |
Minimum_dt_but_still_proceed | oomph::Problem | protected |
Must_recompute_load_balance_for_assembly | oomph::Problem | private |
ndof() const | oomph::Problem | inline |
newton_solve() | oomph::Problem | |
newton_solve(unsigned const &max_adapt) | oomph::Problem | |
newton_solve_continuation(double *const ¶meter_pt) | oomph::Problem | protected |
newton_solve_continuation(double *const ¶meter_pt, DoubleVector &z) | oomph::Problem | protected |
newton_solver_tolerance() | oomph::Problem | inline |
Newton_solver_tolerance | oomph::Problem | protected |
nglobal_data() const | oomph::Problem | inline |
Nnewton_iter_taken | oomph::Problem | protected |
nsub_mesh() const | oomph::Problem | inline |
ntime_stepper() const | oomph::Problem | inline |
Numerical_zero_for_sparse_assembly | oomph::Problem | protected |
operator=(const Problem &)=delete | oomph::Problem | |
oomph::ExplicitTimeSteppableObject::operator=(const ExplicitTimeSteppableObject &)=delete | oomph::ExplicitTimeSteppableObject | |
p_adapt(unsigned &n_refined, unsigned &n_unrefined) | oomph::Problem | |
p_adapt() | oomph::Problem | inline |
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::Problem | inline |
p_refine_uniformly(const Vector< unsigned > &nrefine_for_mesh, DocInfo &doc_info) | oomph::Problem | inline |
p_refine_uniformly(DocInfo &doc_info) | oomph::Problem | inline |
p_refine_uniformly() | oomph::Problem | inline |
p_refine_uniformly(const unsigned &i_mesh, DocInfo &doc_info) | oomph::Problem | |
p_refine_uniformly(const unsigned &i_mesh) | oomph::Problem | inline |
p_refine_uniformly_and_prune(const Vector< unsigned > &nrefine_for_mesh) | oomph::Problem | inline |
p_refine_uniformly_and_prune(const Vector< unsigned > &nrefine_for_mesh, DocInfo &doc_info) | oomph::Problem | inline |
p_refine_uniformly_and_prune(DocInfo &doc_info) | oomph::Problem | inline |
p_refine_uniformly_aux(const Vector< unsigned > &nrefine_for_mesh, DocInfo &doc_info, const bool &prune) | oomph::Problem | private |
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::Problem | private |
Parallel_sparse_assemble_previous_allocation | oomph::Problem | private |
Parameter_current | oomph::Problem | protected |
Parameter_derivative | oomph::Problem | protected |
partition_global_mesh(Mesh *&global_mesh_pt, DocInfo &doc_info, Vector< unsigned > &element_domain, const bool &report_stats=false) | oomph::Problem | virtual |
Pause_at_end_of_sparse_assembly | oomph::Problem | protected |
Perform_assembly_using_lists enum value | oomph::Problem | protected |
Perform_assembly_using_maps enum value | oomph::Problem | protected |
Perform_assembly_using_two_arrays enum value | oomph::Problem | protected |
Perform_assembly_using_two_vectors enum value | oomph::Problem | protected |
Perform_assembly_using_vectors_of_pairs enum value | oomph::Problem | protected |
Problem() | oomph::Problem | |
Problem(const Problem &dummy)=delete | oomph::Problem | |
problem_has_been_distributed() | oomph::Problem | inline |
Problem_has_been_distributed | oomph::Problem | protected |
problem_is_nonlinear(const bool &prob_lin) | oomph::Problem | inline |
Problem_is_nonlinear | oomph::Problem | protected |
Problem_matrix_distribution enum value | oomph::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::Problem | inline |
read(std::ifstream &restart_file, bool &unsteady_restart) | oomph::Problem | virtual |
read(std::ifstream &restart_file) | oomph::Problem | inlinevirtual |
rebuild_global_mesh() | oomph::Problem | |
recompute_load_balanced_assembly() | oomph::Problem | private |
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::Problem | inline |
refine_uniformly(const Vector< unsigned > &nrefine_for_mesh, DocInfo &doc_info) | oomph::Problem | inline |
refine_uniformly(DocInfo &doc_info) | oomph::Problem | inline |
refine_uniformly() | oomph::Problem | inline |
refine_uniformly(const unsigned &i_mesh, DocInfo &doc_info) | oomph::Problem | |
refine_uniformly(const unsigned &i_mesh) | oomph::Problem | inline |
refine_uniformly_and_prune(const Vector< unsigned > &nrefine_for_mesh) | oomph::Problem | inline |
refine_uniformly_and_prune(const Vector< unsigned > &nrefine_for_mesh, DocInfo &doc_info) | oomph::Problem | inline |
refine_uniformly_and_prune(DocInfo &doc_info) | oomph::Problem | inline |
refine_uniformly_aux(const Vector< unsigned > &nrefine_for_mesh, DocInfo &doc_info, const bool &prune) | oomph::Problem | private |
Relaxation_factor | oomph::Problem | protected |
remove_duplicate_data(Mesh *const &mesh_pt, bool &actually_removed_some_data) | oomph::Problem | private |
remove_null_pointers_from_external_halo_node_storage() | oomph::Problem | private |
reset_arc_length_parameters() | oomph::Problem | inline |
reset_assembly_handler_to_default() | oomph::Problem | |
restore_dof_values() | oomph::Problem | |
Saved_dof_pt | oomph::Problem | private |
Scale_arc_length | oomph::Problem | protected |
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::Problem | private |
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::Problem | private |
set_analytic_dparameter(double *const ¶meter_pt) | oomph::Problem | inline |
set_analytic_hessian_products() | oomph::Problem | inline |
set_consistent_pinned_values_for_continuation() | oomph::Problem | protected |
set_default_first_and_last_element_for_assembly() | oomph::Problem | |
set_default_partition_in_load_balance() | oomph::Problem | inline |
set_dofs(const DoubleVector &dofs) | oomph::Problem | virtual |
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::Problem | inline |
set_initial_condition() | oomph::Problem | inlineprotectedvirtual |
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::Problem | private |
setup_dof_halo_scheme() | oomph::Problem | protected |
setup_element_count_per_dof() | oomph::Problem | protected |
shift_time_values() | oomph::Problem | virtual |
Shut_up_in_newton_solve | oomph::Problem | |
sign_of_jacobian() | oomph::Problem | inline |
Sign_of_jacobian | oomph::Problem | protected |
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::Problem | inline |
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::Problem | inline |
solve_eigenproblem(const unsigned &n_eval, Vector< std::complex< double >> &alpha, Vector< double > &beta, const bool &steady=true) | oomph::Problem | inline |
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::Problem | inline |
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::Problem | protectedvirtual |
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::Problem | privatevirtual |
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::Problem | privatevirtual |
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::Problem | privatevirtual |
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::Problem | privatevirtual |
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::Problem | privatevirtual |
Sparse_assemble_with_arrays_allocation_increment | oomph::Problem | protected |
Sparse_assemble_with_arrays_initial_allocation | oomph::Problem | protected |
Sparse_assemble_with_arrays_previous_allocation | oomph::Problem | protected |
Sparse_assembly_method | oomph::Problem | protected |
SpatialErrorEstimatorFctPt typedef | oomph::Problem | |
SpatialErrorEstimatorWithDocFctPt typedef | oomph::Problem | |
steady_newton_solve(unsigned const &max_adapt=0) | oomph::Problem | |
store_current_dof_values() | oomph::Problem | |
Store_local_dof_pt_in_elements | oomph::Problem | private |
Sub_mesh_pt | oomph::Problem | private |
Suppress_warning_about_actions_before_read_unstructured_meshes | oomph::Problem | static |
symmetrise_eigenfunction_for_adaptive_pitchfork_tracking() | oomph::Problem | virtual |
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 | |
Theta_squared | oomph::Problem | protected |
time() | oomph::Problem | virtual |
time() const | oomph::Problem | |
Time_adaptive_newton_crash_on_solve_fail | oomph::Problem | protected |
time_adaptive_newton_crash_on_solve_fail() | oomph::Problem | inline |
Time_pt | oomph::Problem | private |
time_pt() | oomph::Problem | inline |
time_pt() const | oomph::Problem | inlinevirtual |
time_stepper_pt() | oomph::Problem | inline |
time_stepper_pt() const | oomph::Problem | inline |
time_stepper_pt(const unsigned &i) | oomph::Problem | inline |
Time_stepper_pt | oomph::Problem | private |
Timestep_reduction_factor_after_nonconvergence | oomph::Problem | protected |
Uniform_matrix_distribution enum value | oomph::Problem | |
unrefine_uniformly() | oomph::Problem | |
unrefine_uniformly(const unsigned &i_mesh) | oomph::Problem | |
unset_analytic_dparameter(double *const ¶meter_pt) | oomph::Problem | inline |
unset_analytic_hessian_products() | oomph::Problem | inline |
unset_default_partition_in_load_balance() | oomph::Problem | inline |
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 | |
Use_continuation_timestepper | oomph::Problem | protected |
Use_default_partition_in_load_balance | oomph::Problem | private |
Use_finite_differences_for_continuation_derivatives | oomph::Problem | protected |
Use_globally_convergent_newton_method | oomph::Problem | private |
use_predictor_values_as_initial_guess() | oomph::Problem | inline |
Use_predictor_values_as_initial_guess | oomph::Problem | private |
~ExplicitTimeSteppableObject() | oomph::ExplicitTimeSteppableObject | inlinevirtual |
~HelmholtzMGProblem() | oomph::HelmholtzMGProblem | inlinevirtual |
~Problem() | oomph::Problem | virtual |