The finite element method using deal.II - 2021/2022
|
|
#include <step-3.h>
Definition at line 55 of file step-3.h.
◆ Step3()
◆ run()
◆ make_grid()
void Step3::make_grid |
( |
| ) |
|
|
protected |
◆ setup_system()
void Step3::setup_system |
( |
| ) |
|
|
protected |
◆ assemble_system()
void Step3::assemble_system |
( |
| ) |
|
|
protected |
Definition at line 59 of file step-3.cc.
64 update_values | update_gradients | update_JxW_values);
71 fe_values.reinit(cell);
74 for (
const unsigned int q_index : fe_values.quadrature_point_indices())
76 for (
const unsigned int i : fe_values.dof_indices())
77 for (
const unsigned int j : fe_values.dof_indices())
79 (fe_values.shape_grad(i, q_index) *
80 fe_values.shape_grad(j, q_index) *
81 fe_values.JxW(q_index));
82 for (
const unsigned int i : fe_values.dof_indices())
83 cell_rhs(i) += (fe_values.shape_value(i, q_index) *
85 fe_values.JxW(q_index));
87 cell->get_dof_indices(local_dof_indices);
88 for (
const unsigned int i : fe_values.dof_indices())
89 for (
const unsigned int j : fe_values.dof_indices())
93 for (
const unsigned int i : fe_values.dof_indices())
94 system_rhs(local_dof_indices[i]) += cell_rhs(i);
96 std::map<types::global_dof_index, double> boundary_values;
◆ solve()
◆ output_results()
void Step3::output_results |
( |
| ) |
const |
|
protected |
◆ Step3Tester
◆ triangulation
◆ fe
◆ dof_handler
◆ sparsity_pattern
◆ system_matrix
◆ solution
Vector<double> Step3::solution |
|
protected |
◆ system_rhs
Vector<double> Step3::system_rhs |
|
protected |
The documentation for this class was generated from the following files:
void add(const size_type i, const size_type j, const double value)
std::vector< types::global_dof_index > local_dof_indices
Vector< double > system_rhs
void refine_global(const unsigned int times=1)
DoFHandler< 2 > dof_handler
void write_vtk(std::ostream &out) const
void cell_matrix(FullMatrix< double > &M, const FEValuesBase< dim > &fe, const FEValuesBase< dim > &fetest, const ArrayView< const std::vector< double >> &velocity, const double factor=1.)
void attach_dof_handler(const DoFHandler< dim, spacedim > &)
void distribute_dofs(const FiniteElement< dim, spacedim > &fe)
const unsigned int degree
SparsityPattern sparsity_pattern
void make_sparsity_pattern(const DoFHandler< dim, spacedim > &dof_handler, SparsityPatternType &sparsity_pattern, const AffineConstraints< number > &constraints=AffineConstraints< number >(), const bool keep_constrained_dofs=true, const types::subdomain_id subdomain_id=numbers::invalid_subdomain_id)
virtual void reinit(const SparsityPattern &sparsity)
virtual void build_patches(const unsigned int n_subdivisions=0)
Triangulation< 2 > triangulation
virtual void reinit(const size_type N, const bool omit_zeroing_entries=false)
void output_results() const
void copy_from(const size_type n_rows, const size_type n_cols, const ForwardIterator begin, const ForwardIterator end)
void hyper_cube(Triangulation< dim, spacedim > &tria, const double left=0., const double right=1., const bool colorize=false)
void add_data_vector(const VectorType &data, const std::vector< std::string > &names, const DataVectorType type=type_automatic, const std::vector< DataComponentInterpretation::DataComponentInterpretation > &data_component_interpretation={})
SparseMatrix< double > system_matrix
unsigned int n_active_cells() const
IteratorRange< active_cell_iterator > active_cell_iterators() const
unsigned int n_dofs_per_cell() const
Vector< double > solution
types::global_dof_index n_dofs() const