/* ------------------------------------------------------------------------ * * SPDX-License-Identifier: LGPL-2.1-or-later * Copyright (C) 1999 - 2024 by the deal.II authors * * This file is part of the deal.II library. * * Part of the source code is dual licensed under Apache-2.0 WITH * LLVM-exception OR LGPL-2.1-or-later. Detailed license information * governing the source code and code contributions can be found in * LICENSE.md and CONTRIBUTING.md at the top level directory of deal.II. * * ------------------------------------------------------------------------ */ #include #include #include #include #include #include #include #include #include #include #include #include #include #include #include #include #include #include #include #include using namespace dealii; template class Step5 { public: Step5(); void run(); private: void setup_system(); void assemble_system(); void solve(); void output_results(const unsigned int cycle) const; Triangulation triangulation; const FE_Q fe; DoFHandler dof_handler; SparsityPattern sparsity_pattern; SparseMatrix system_matrix; Vector solution; Vector system_rhs; }; template double coefficient(const Point &p) { if (p.square() < 0.5 * 0.5) return 20; else return 1; } template Step5::Step5() : fe(/* polynomial degree = */ 1) , dof_handler(triangulation) {} template void Step5::setup_system() { dof_handler.distribute_dofs(fe); std::cout << " Number of degrees of freedom: " << dof_handler.n_dofs() << std::endl; DynamicSparsityPattern dsp(dof_handler.n_dofs()); DoFTools::make_sparsity_pattern(dof_handler, dsp); sparsity_pattern.copy_from(dsp); system_matrix.reinit(sparsity_pattern); solution.reinit(dof_handler.n_dofs()); system_rhs.reinit(dof_handler.n_dofs()); } template void Step5::assemble_system() { const QGauss quadrature_formula(fe.degree + 1); FEValues fe_values(fe, quadrature_formula, update_values | update_gradients | update_quadrature_points | update_JxW_values); const unsigned int dofs_per_cell = fe.n_dofs_per_cell(); FullMatrix cell_matrix(dofs_per_cell, dofs_per_cell); Vector cell_rhs(dofs_per_cell); std::vector local_dof_indices(dofs_per_cell); for (const auto &cell : dof_handler.active_cell_iterators()) { fe_values.reinit(cell); cell_matrix = 0.; cell_rhs = 0.; for (const unsigned int q_index : fe_values.quadrature_point_indices()) { const double current_coefficient = coefficient(fe_values.quadrature_point(q_index)); for (const unsigned int i : fe_values.dof_indices()) { for (const unsigned int j : fe_values.dof_indices()) cell_matrix(i, j) += (current_coefficient * // a(x_q) fe_values.shape_grad(i, q_index) * // grad phi_i(x_q) fe_values.shape_grad(j, q_index) * // grad phi_j(x_q) fe_values.JxW(q_index)); // dx cell_rhs(i) += (fe_values.shape_value(i, q_index) * // phi_i(x_q) 1.0 * // f(x_q) fe_values.JxW(q_index)); // dx } } cell->get_dof_indices(local_dof_indices); for (const unsigned int i : fe_values.dof_indices()) { for (const unsigned int j : fe_values.dof_indices()) system_matrix.add(local_dof_indices[i], local_dof_indices[j], cell_matrix(i, j)); system_rhs(local_dof_indices[i]) += cell_rhs(i); } } std::map boundary_values; VectorTools::interpolate_boundary_values(dof_handler, types::boundary_id(0), Functions::ZeroFunction(), boundary_values); MatrixTools::apply_boundary_values(boundary_values, system_matrix, solution, system_rhs); } template void Step5::solve() { SolverControl solver_control(1000, 1e-6 * system_rhs.l2_norm()); SolverCG> solver(solver_control); PreconditionSSOR> preconditioner; preconditioner.initialize(system_matrix, 1.2); solver.solve(system_matrix, solution, system_rhs, preconditioner); std::cout << " " << solver_control.last_step() << " CG iterations needed to obtain convergence." << std::endl; } template void Step5::output_results(const unsigned int cycle) const { DataOut data_out; data_out.attach_dof_handler(dof_handler); data_out.add_data_vector(solution, "solution"); data_out.build_patches(); std::ofstream output("solution-" + std::to_string(cycle) + ".vtu"); data_out.write_vtu(output); } template void Step5::run() { GridIn grid_in; grid_in.attach_triangulation(triangulation); std::ifstream input_file("circle-grid.inp"); Assert(dim == 2, ExcNotImplemented()); grid_in.read_ucd(input_file); const SphericalManifold boundary; triangulation.set_all_manifold_ids_on_boundary(0); triangulation.set_manifold(0, boundary); for (unsigned int cycle = 0; cycle < 6; ++cycle) { std::cout << "Cycle " << cycle << ':' << std::endl; if (cycle != 0) triangulation.refine_global(1); std::cout << " Number of active cells: " << triangulation.n_active_cells() << std::endl << " Total number of cells: " << triangulation.n_cells() << std::endl; setup_system(); assemble_system(); solve(); output_results(cycle); } } int main() { cout << "\n"; cout << "step-5():\n"; cout << " dealii example code.\n"; cout << "\n"; Step5<2> laplace_problem_2d; laplace_problem_2d.run(); cout << "\n"; cout << "step-5():\n"; cout << " Normal end of execution.\n"; return 0; }