| libMesh
    | 
Go to the source code of this file.
| Functions | |
| void | assemble_laplace (EquationSystems &es, const std::string &system_name) | 
| Number | exact_solution (const Point &p, const Parameters &, const std::string &, const std::string &) | 
| Gradient | exact_derivative (const Point &p, const Parameters &, const std::string &, const std::string &) | 
| int | main (int argc, char **argv) | 
| Variables | |
| unsigned int | dim = 2 | 
| unsigned int | n_vars = 1 | 
| bool | singularity = true | 
| void assemble_laplace | ( | EquationSystems & | es, | 
| const std::string & | system_name | ||
| ) | 
Definition at line 708 of file adaptivity_ex3.C.
References libMesh::SparseMatrix< T >::add_matrix(), libMesh::NumericVector< T >::add_vector(), libMesh::FEGenericBase< OutputType >::build(), libMesh::FEType::default_quadrature_rule(), libMesh::System::get_dof_map(), libMesh::EquationSystems::get_mesh(), libMesh::EquationSystems::get_system(), libMesh::ImplicitSystem::get_system_matrix(), libMesh::libmesh_ignore(), mesh, libMesh::MeshBase::mesh_dimension(), n_vars, libMesh::PerfLog::pop(), libMesh::Utility::pow(), libMesh::PerfLog::push(), libMesh::Real, libMesh::DenseSubVector< T >::reposition(), libMesh::DenseSubMatrix< T >::reposition(), libMesh::DenseVector< T >::resize(), libMesh::DenseMatrix< T >::resize(), libMesh::ExplicitSystem::rhs, and singularity.
Referenced by main().
| Gradient exact_derivative | ( | const Point & | p, | 
| const Parameters & | , | ||
| const std::string & | , | ||
| const std::string & | |||
| ) | 
Definition at line 642 of file adaptivity_ex3.C.
References dim, libMesh::pi, libMesh::Utility::pow(), libMesh::Real, and singularity.
Referenced by main().
| Number exact_solution | ( | const Point & | p, | 
| const Parameters & | , | ||
| const std::string & | , | ||
| const std::string & | |||
| ) | 
Definition at line 602 of file adaptivity_ex3.C.
References dim, libMesh::pi, libMesh::Utility::pow(), libMesh::Real, and singularity.
Referenced by main().
Definition at line 123 of file adaptivity_ex3.C.
References libMesh::DofMap::add_algebraic_ghosting_functor(), libMesh::DofMap::add_dirichlet_boundary(), libMesh::MeshRefinement::add_p_to_h_refinement(), libMesh::System::add_variable(), libMesh::MeshBase::all_complete_order(), libMesh::MeshBase::all_second_order(), libMesh::MeshTools::Modification::all_tri(), assemble_laplace(), libMesh::System::attach_assemble_function(), libMesh::ExactErrorEstimator::attach_exact_deriv(), libMesh::ExactSolution::attach_exact_deriv(), libMesh::ExactErrorEstimator::attach_exact_value(), libMesh::ExactSolution::attach_exact_value(), libMesh::MeshTools::Generation::build_extrusion(), libMesh::MeshTools::Generation::build_line(), libMesh::MeshBase::clear(), libMesh::MeshRefinement::coarsen_fraction(), libMesh::ExactSolution::compute_error(), libMesh::default_solver_package(), dim, libMesh::PatchRecoveryErrorEstimator::estimate_error(), libMesh::UniformRefinementEstimator::estimate_error(), libMesh::JumpErrorEstimator::estimate_error(), libMesh::ExactErrorEstimator::estimate_error(), libMesh::SmoothnessEstimator::estimate_smoothness(), exact_derivative(), exact_grad(), exact_solution(), libMesh::ExactSolution::extra_quadrature_order(), libMesh::LinearImplicitSystem::final_linear_residual(), libMesh::MeshRefinement::flag_elements_by_error_fraction(), libMesh::System::get_dof_map(), libMesh::ExactSolution::h1_error(), libMesh::TriangleWrapper::init(), libMesh::INVALID_SOLVER_PACKAGE, libMesh::ExactSolution::l2_error(), libMesh::libmesh_assert(), libMesh::libmesh_isnan(), libMesh::MeshRefinement::max_h_level(), libMesh::ErrorVector::mean(), mesh, libMesh::LinearImplicitSystem::n_linear_iterations(), n_vars, libMesh::out, libMesh::ErrorVector::plot_error(), libMesh::Utility::pow(), libMesh::MeshBase::read(), libMesh::Real, libMesh::MeshRefinement::refine_and_coarsen_elements(), libMesh::MeshRefinement::refine_fraction(), libMesh::HPSingularity::select_refinement(), libMesh::HPCoarsenTest::select_refinement(), libMesh::HPSingularity::singular_points, singularity, libMesh::LinearImplicitSystem::solve(), libMesh::MeshRefinement::switch_h_to_p_refinement(), libMesh::TOLERANCE, libMesh::MeshRefinement::uniformly_p_refine(), libMesh::MeshRefinement::uniformly_refine(), libMesh::JumpErrorEstimator::use_unweighted_quadrature_rules, and libMesh::ExodusII_IO::write_equation_systems().
| unsigned int dim = 2 | 
Definition at line 114 of file adaptivity_ex3.C.
Referenced by libMesh::ExactSolution::_compute_error(), libMesh::FEMContext::_do_elem_position_set(), libMesh::UniformRefinementEstimator::_estimate_error(), libMesh::MeshFunction::_gradient_on_elem(), libMesh::FEInterface::all_shape_derivs(), libMesh::FEInterface::all_shapes(), alternative_fe_assembly(), assemble(), LinearElasticity::assemble(), assemble_1D(), AssembleOptimization::assemble_A_and_F(), libMesh::ClawSystem::assemble_advection_matrices(), libMesh::ClawSystem::assemble_avg_coupling_matrices(), assemble_biharmonic(), libMesh::ClawSystem::assemble_boundary_condition_matrices(), assemble_cd(), assemble_divgrad(), assemble_elasticity(), assemble_ellipticdg(), assemble_func(), assemble_graddiv(), assemble_helmholtz(), assemble_mass(), assemble_matrices(), assemble_poisson(), assemble_SchroedingerEquation(), assemble_shell(), assemble_stokes(), assemble_wave(), libMesh::FEMContext::attach_quadrature_rules(), libMesh::FEGenericBase< FEOutputType< T >::type >::build(), libMesh::FEGenericBase< FEOutputType< T >::type >::build_InfFE(), libMesh::EquationSystems::build_parallel_solution_vector(), libMesh::EquationSystems::build_variable_names(), libMesh::System::calculate_norm(), libMesh::JumpErrorEstimator::coarse_n_flux_faces_increment(), libMesh::FEGenericBase< FEOutputType< T >::type >::coarsened_dof_values(), SolutionFunction< dim >::component(), SolutionGradient< dim >::component(), libMesh::FEMap::compute_affine_map(), libMesh::FEInterface::compute_data(), libMesh::FEMap::compute_edge_map(), compute_enriched_soln(), libMesh::InfFE< Dim, T_radial, T_map >::compute_face_functions(), libMesh::FEXYZMap::compute_face_map(), libMesh::FEMap::compute_face_map(), libMesh::FEXYZ< Dim >::compute_face_values(), compute_jacobian(), libMesh::FEMap::compute_map(), libMesh::VariationalSmootherSystem::compute_mesh_quality_info(), libMesh::FEMap::compute_null_map(), compute_residual(), libMesh::FEGenericBase< FEOutputType< T >::type >::compute_shape_functions(), libMesh::InfFE< Dim, T_radial, T_map >::compute_shape_functions(), libMesh::FEXYZ< Dim >::compute_shape_functions(), libMesh::FEMap::compute_single_point_map(), compute_stresses(), LinearElasticityWithContact::compute_stresses(), LinearElasticity::compute_stresses(), LargeDeformationElasticity::compute_stresses(), libMesh::VariationalSmootherConstraint::constrain(), libMesh::VariationalSmootherConstraint::constrain_node_to_line(), libMesh::VariationalSmootherConstraint::constrain_node_to_plane(), libMesh::InfFERadial::decay(), libMesh::InfFERadial::decay_deriv(), libMesh::FEType::default_quadrature_rule(), libMesh::MeshBase::detect_interior_parents(), libMesh::VariationalSmootherConstraint::determine_constraint(), libMesh::MeshFunction::discontinuous_value(), NodalNeighborsTest::do_test(), libMesh::FEMContext::elem_fe_reinit(), libMesh::FEMContext::elem_position_get(), NavierSystem::element_constraint(), NavierSystem::element_time_derivative(), SolidSystem::element_time_derivative(), HeatSystem::element_time_derivative(), libMesh::VariationalSmootherSystem::element_time_derivative(), libMesh::RBEIMConstruction::enrich_eim_approximation_on_interiors(), libMesh::JumpErrorEstimator::estimate_error(), libMesh::ExactErrorEstimator::estimate_error(), libMesh::OldSolutionValue< Output, point_output >::eval_at_node(), libMesh::OldSolutionCoefs< Output, point_output >::eval_mixed_derivatives(), libMesh::OldSolutionValue< Output, point_output >::eval_mixed_derivatives(), exact_derivative(), exact_solution(), fe_assembly(), libMesh::DynaIO::find_elem_definition(), libMesh::ElemInternal::find_interior_neighbors(), libMesh::EquationSystems::find_variable_numbers(), libMesh::MeshRefinement::flag_elements_by_elem_fraction(), libMesh::MeshRefinement::flag_elements_by_nelem_target(), NavierSystem::forcing(), form_functionA(), form_functionB(), form_matrixA(), libMesh::ClawSystem::get_advection_matrix(), libMesh::ClawSystem::get_avg_matrix(), libMesh::ClawSystem::get_boundary_condition_matrix(), libMesh::FEMContext::get_element_fe(), libMesh::FEMContext::get_element_qrule(), libMesh::get_jacobian_at_qp(), libMesh::FEMContext::get_side_fe(), libMesh::FEMContext::get_side_qrule(), libMesh::VariationalSmootherSystem::get_target_to_reference_jacobian(), libMesh::QGrundmann_Moller::gm_rule(), libMesh::MeshFunction::hessian(), libMesh::FEInterface::ifem_compute_data(), libMesh::FEInterface::ifem_inverse_map(), libMesh::FEInterface::ifem_map(), libMesh::FEInterface::ifem_n_dofs(), libMesh::FEInterface::ifem_n_dofs_at_node(), libMesh::FEInterface::ifem_n_dofs_per_elem(), libMesh::FEInterface::ifem_n_shape_functions(), libMesh::FEInterface::ifem_nodal_soln(), libMesh::FEInterface::ifem_shape(), libMesh::FEInterface::ifem_shape_deriv(), libMesh::LaplacianErrorEstimator::init_context(), HilbertSystem::init_context(), libMesh::DiscontinuityMeasure::init_context(), libMesh::WrappedFunctor< Output >::init_context(), HeatSystem::init_context(), libMesh::KellyErrorEstimator::init_context(), libMesh::FEMSystem::init_context(), libMesh::VariationalSmootherSystem::init_context(), libMesh::RBEIMConstruction::init_context(), libMesh::OldSolutionBase< Output, point_output >::init_context(), NavierSystem::init_data(), SolidSystem::init_data(), libMesh::FEMContext::init_internal_data(), libMesh::FEMap::init_reference_to_physical_map(), libMesh::LaplacianErrorEstimator::internal_side_integration(), libMesh::InfFEMap::inverse_map(), libMesh::FEMap::inverse_map(), libMesh::FEInterface::inverse_map(), LaplaceYoung::jacobian(), LargeDeformationElasticity::jacobian(), libMesh::PointLocatorNanoflann::kdtree_get_pt(), libMesh::InverseDistanceInterpolation< KDDim >::PointListAdaptor< KDDim >::kdtree_get_pt(), libMesh::VectorOfNodesAdaptor::kdtree_get_pt(), libMesh::SmoothnessEstimator::legepoly(), libMesh::LIBMESH_DEFAULT_VECTORIZED_FE(), main(), libMesh::InfFEMap::map(), libMesh::FEMap::map(), libMesh::FEInterface::map(), libMesh::HCurlFETransformation< OutputShape >::map_curl(), libMesh::H1FETransformation< OutputShape >::map_curl(), libMesh::H1FETransformation< OutputShape >::map_d2phi(), libMesh::FEMap::map_deriv(), libMesh::HDivFETransformation< OutputShape >::map_div(), libMesh::H1FETransformation< OutputShape >::map_div(), libMesh::H1FETransformation< OutputShape >::map_dphi(), libMesh::HCurlFETransformation< OutputShape >::map_phi(), libMesh::H1FETransformation< OutputShape >::map_phi(), libMesh::HDivFETransformation< OutputShape >::map_phi(), NavierSystem::mass_residual(), libMesh::FEInterface::n_dofs(), libMesh::FEInterface::n_dofs_at_node(), libMesh::FEInterface::n_dofs_at_node_function(), libMesh::FEInterface::n_dofs_per_elem(), libMesh::FEInterface::n_shape_functions(), libMesh::FEInterface::nodal_soln(), OverlappingCouplingFunctor::operator()(), libMesh::OverlapCoupling::operator()(), libMesh::WeightedPatchRecoveryErrorEstimator::EstimateError::operator()(), libMesh::SmoothnessEstimator::EstimateSmoothness::operator()(), libMesh::PatchRecoveryErrorEstimator::EstimateError::operator()(), libMesh::MeshFunction::operator()(), libMesh::BoundaryProjectSolution::operator()(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::SortAndCopy::operator()(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::ProjectVertices::operator()(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::ProjectEdges::operator()(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::ProjectSides::operator()(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::ProjectInteriors::operator()(), libMesh::System::point_gradient(), NavierSystem::postprocess(), libMesh::RBParametrizedFunction::preevaluate_parametrized_function_on_mesh(), libMesh::RBParametrizedFunction::preevaluate_parametrized_function_on_mesh_sides(), process_cmd_line(), libMesh::QClough::QClough(), libMesh::QGauss::QGauss(), libMesh::QGrid::QGrid(), libMesh::QGrundmann_Moller::QGrundmann_Moller(), libMesh::QMonomial::QMonomial(), libMesh::QNodal::QNodal(), libMesh::QSimpson::QSimpson(), libMesh::QTrap::QTrap(), libMesh::rational_fe_weighted_shapes(), libMesh::rational_fe_weighted_shapes_derivs(), libMesh::FE< Dim, LAGRANGE_VEC >::reinit(), libMesh::JumpErrorEstimator::reinit_sides(), LaplaceYoung::residual(), LargeDeformationElasticity::residual(), LinearElasticityWithContact::residual_and_jacobian(), libMesh::FEMap::resize_quadrature_map_vectors(), SolidSystem::save_initial_mesh(), libMesh::BoundingBox::scale(), libMesh::HPCoarsenTest::select_refinement(), ElasticitySystem::set_dim(), libMesh::OverlapCoupling::set_quadrature_rule(), PerElemTest< elem_type >::setUp(), setup(), libMesh::FEInterface::shape(), libMesh::FEInterface::shape_deriv(), libMesh::FEInterface::shape_deriv_function(), libMesh::FEInterface::shape_function(), libMesh::FEInterface::shape_second_deriv(), libMesh::FEInterface::shape_second_deriv_function(), libMesh::FEInterface::shapes(), NavierSystem::side_constraint(), libMesh::FEMContext::side_fe_reinit(), libMesh::FEInterface::side_nodal_soln(), libMesh::PatchRecoveryErrorEstimator::specpoly(), libMesh::GenericProjector< FFunctor, GFunctor, FValue, ProjectionAction >::SubFunctor::SubFunctor(), InfFERadialTest::testInfQuants(), InfFERadialTest::testInfQuants_numericDeriv(), PointLocatorTest::testLocator(), QuadratureTest::testPolynomials(), SlitMeshRefinedSystemTest::testRestart(), InfFERadialTest::testSides(), InfFERadialTest::testSingleOrder(), SlitMeshRefinedSystemTest::testSystem(), MeshSmootherTest::testVariationalSmoother(), libMesh::trace(), libMesh::FEType::unweighted_quadrature_rule(), libMesh::FEMContext::use_default_quadrature_rules(), libMesh::FEMContext::use_unweighted_quadrature_rules(), libMesh::MeshTools::volume(), libMesh::ExodusII_IO::write_as_dimension(), libMesh::ExodusII_IO_Helper::write_as_dimension(), libMesh::EnsightIO::write_scalar_ascii(), and libMesh::EnsightIO::write_vector_ascii().
| unsigned int n_vars = 1 | 
Definition at line 117 of file adaptivity_ex3.C.
Referenced by libMesh::UniformRefinementEstimator::_estimate_error(), assemble_laplace(), libMesh::WrappedFunction< Output >::component(), libMesh::RBEIMEvaluation::distribute_bfs(), libMesh::JumpErrorEstimator::estimate_error(), libMesh::AdjointResidualErrorEstimator::estimate_error(), libMesh::ExactErrorEstimator::estimate_error(), libMesh::ErrorEstimator::estimate_errors(), libMesh::RBEIMEvaluation::gather_bfs(), libMesh::RBEIMEvaluation::get_interior_basis_function_as_vec_helper(), libMesh::RBEIMEvaluation::get_interior_basis_function_sizes(), libMesh::LaplacianErrorEstimator::init_context(), libMesh::DiscontinuityMeasure::init_context(), libMesh::KellyErrorEstimator::init_context(), libMesh::PetscDMWrapper::init_petscdm(), libMesh::RadialBasisInterpolation< KDDim, RBF >::interpolate_field_data(), main(), libMesh::RBEIMEvaluation::node_distribute_bfs(), libMesh::RBEIMEvaluation::node_gather_bfs(), libMesh::WrappedFunction< Output >::operator()(), libMesh::WeightedPatchRecoveryErrorEstimator::EstimateError::operator()(), libMesh::SmoothnessEstimator::EstimateSmoothness::operator()(), libMesh::PatchRecoveryErrorEstimator::EstimateError::operator()(), libMesh::RadialBasisInterpolation< KDDim, RBF >::prepare_for_use(), libMesh::InterMeshProjection::project_system_vectors(), libMesh::System::project_vector(), libMesh::System::projection_matrix(), libMesh::RBEIMEvaluation::read_in_interior_basis_functions(), libMesh::RBEIMEvaluation::read_in_node_basis_functions(), libMesh::RBEIMEvaluation::read_in_side_basis_functions(), libMesh::JumpErrorEstimator::reinit_sides(), libMesh::HPCoarsenTest::select_refinement(), libMesh::RBEIMEvaluation::side_distribute_bfs(), libMesh::RBEIMEvaluation::side_gather_bfs(), libMesh::MEDITIO::write_ascii(), libMesh::GMVIO::write_ascii_new_impl(), libMesh::GMVIO::write_ascii_old_impl(), libMesh::GMVIO::write_binary(), libMesh::GMVIO::write_discontinuous_gmv(), libMesh::UCDIO::write_header(), libMesh::RBEIMEvaluation::write_out_interior_basis_functions(), libMesh::RBEIMEvaluation::write_out_node_basis_functions(), libMesh::RBEIMEvaluation::write_out_side_basis_functions(), libMesh::GmshIO::write_post(), and libMesh::GnuPlotIO::write_solution().
| bool singularity = true | 
Definition at line 120 of file adaptivity_ex3.C.
Referenced by assemble_laplace(), exact_derivative(), exact_solution(), and main().
 1.8.14
 1.8.14