These were found by cppcheck.
// be used to store the
// indices each Lagrange dof
// accesses
- std::map<size_type, size_type> local_index;
const SparsityPattern &structure = M.get_sparsity_pattern();
for (size_type row=0; row<M.m(); ++row)
AssertDimension (n_fe, constraint.size());
std::vector<types::global_dof_index> local_dof_indices;
- std::vector<std::vector<std::vector<unsigned int> > > lexicographic_inv(n_fe);
internal::MatrixFreeFunctions::ConstraintValues<double> constraint_values;
- std::vector<unsigned int> constraint_indices;
for (unsigned int no=0; no<n_fe; ++no)
{
OutVector &dst,
const MGLevelObject<Vector<number> > &src) const
{
- const FiniteElement<dim> &fe = mg_dof_handler.get_fe();
- const unsigned int dofs_per_cell = fe.dofs_per_cell;
-
- std::vector<types::global_dof_index> global_dof_indices (dofs_per_cell);
- std::vector<types::global_dof_index> level_dof_indices (dofs_per_cell);
-
typename DoFHandler<dim,spacedim>::active_cell_iterator
level_cell = mg_dof_handler.begin_active();
const typename DoFHandler<dim,spacedim>::active_cell_iterator
ExcInternalError());
}
- const unsigned int max_rep_points = *std::max_element (n_rep_points.begin(),
- n_rep_points.end());
std::vector<types::global_dof_index> dofs_on_cell (fe.max_dofs_per_cell());
- std::vector<Point<spacedim> > rep_points (max_rep_points);
// get space for the values of the
// function at the rep support points.
for (; patch != patches.end(); ++patch)
{
n_subdivisions = patch->n_subdivisions;
- n = n_subdivisions + 1;
-
for (unsigned int i2 = 0; i2 < n_subdivisions; ++i2)
{
for (unsigned int i1 = 0; i1 < n_subdivisions; ++i1)
for (patch = patches.begin(); patch != patches.end(); ++patch)
{
n_subdivisions = patch->n_subdivisions;
- n = n_subdivisions + 1;
for (unsigned int i2 = 0; i2 < n_subdivisions; ++i2)
{
bool Selection::match (const std::string &test_string) const
{
- std::vector<std::string> choices;
std::string tmp(sequence);
// check the different possibilities
while (tmp.find('|') != std::string::npos)
void ParameterHandler::enter_subsection (const std::string &subsection)
{
- const std::string current_path = get_current_path ();
-
// if necessary create subsection
if (!entries->get_child_optional (get_current_full_path(subsection)))
entries->add_child (get_current_full_path(subsection),
p != current_section.not_found(); ++p)
if (is_parameter_node (p->second) == true)
{
- const std::string value = p->second.get<std::string>("value");
-
// print name and value
out << std::setw(overall_indent_level*2) << ""
<< "set "
// Store the information that will be sent to the adjacent cells
// on other subdomains
adjacent_cell = vertex_to_cell[cell->vertex_index(i)].begin();
- std::vector<types::subdomain_id> subdomain_ids;
for (; adjacent_cell!=end_adj_cell; ++adjacent_cell)
if ((*adjacent_cell)->subdomain_id()!=cell->subdomain_id())
{
// points locations are dofs locations
AssertThrow (dof_handler->get_fe ().has_support_points (), ExcNotImplemented ());
- // FEValues object to extract quadrature
- // points from
- std::vector <Point <dim> >
- unit_support_points = dof_handler->get_fe ().get_unit_support_points ();
-
// While in general quadrature points seems
// to refer to Gauss quadrature points, in
// this case the quadrature points are
// points locations are dofs locations
AssertThrow (dof_handler->get_fe ().has_support_points (), ExcNotImplemented ());
- // FEValues object to extract quadrature
- // points from
- std::vector <Point <dim> > unit_support_points = dof_handler->get_fe ().get_unit_support_points ();
-
// While in general quadrature points seems
// to refer to Gauss quadrature points, in
// this case the quadrature points are