int t0 = 1;
unsigned int t1 = 2;
- types::boundary_id t2 = 3;
+ unsigned char t2 = 3;
std::string t3 = "Ciao";
double t4 = 4.0;
bool t5 = true;
int t0 = 1;
unsigned int t1 = 2;
- types::boundary_id t2 = 3;
+ unsigned char t2 = 3;
std::string t3 = "Ciao";
double t4 = 4.0;
std::vector<int > t10(2, t0);
std::vector<unsigned int > t11(2, t1);
- std::vector<types::boundary_id > t12(2, t2);
+ std::vector<unsigned char > t12(2, t2);
std::vector<std::string > t13(2, t3);
std::vector<double > t14(2, t4);
int t0 = 1;
unsigned int t1 = 2;
- types::boundary_id t2 = 3;
+ unsigned char t2 = 3;
std::string t3 = "Ciao";
double t4 = 4.0;
std::map<unsigned int, int > t10;
std::map<unsigned int, unsigned int > t11;
- std::map<unsigned int, types::boundary_id > t12;
+ std::map<unsigned int, unsigned char > t12;
std::map<unsigned int, std::string > t13;
std::map<unsigned int, double > t14;
face!=tria.end_face(); ++face)
{
deallog << face << " "
- << (int)face->boundary_id() << " "
+ << face->boundary_id() << " "
<< '<' << face->vertex(0) << '>' << std::endl
<< " <" << face->vertex(1) << '>' << std::endl
<< " <" << face->vertex(2) << '>' << std::endl
face!=tria.end_face(); ++face)
{
deallog << face << " "
- << (int)face->boundary_id() << " "
+ << face->boundary_id() << " "
<< face->vertex_index(0)
<< " <" << face->vertex(0) << '>'
<< std::endl
GridGenerator::hyper_cube (tria);
deallog << "Coarse mesh:" << std::endl;
- deallog << "Left vertex=" << (int)tria.begin_active()->face(0)->boundary_id() << std::endl;
- deallog << "Right vertex=" << (int)tria.begin_active()->face(1)->boundary_id() << std::endl;
+ deallog << "Left vertex=" << tria.begin_active()->face(0)->boundary_id() << std::endl;
+ deallog << "Right vertex=" << tria.begin_active()->face(1)->boundary_id() << std::endl;
tria.refine_global (2);
cell != tria.end(); ++cell)
{
deallog << "Cell: " << cell << std::endl;
- deallog << "Left vertex=" << (int)cell->face(0)->boundary_id() << std::endl;
- deallog << "Right vertex=" << (int)cell->face(1)->boundary_id() << std::endl;
+ deallog << "Left vertex=" << cell->face(0)->boundary_id() << std::endl;
+ deallog << "Right vertex=" << cell->face(1)->boundary_id() << std::endl;
}
}
{
deallog << "cell: " << cell
<< ", material_id: "
- << (int)cell->material_id()
+ << cell->material_id()
<< ", manifold_id: "
- << (int)cell->manifold_id() << std::endl;
+ << cell->manifold_id() << std::endl;
for (unsigned int f=0; f<GeometryInfo<dim>::faces_per_cell; ++f)
deallog << "face: " << cell->face(f)
<< ", boundary_id: "
- << (int)cell->face(f)->boundary_id()
+ << cell->face(f)->boundary_id()
<< ", manifold_id: "
- << (int)cell->face(f)->manifold_id() << std::endl;
+ << cell->face(f)->manifold_id() << std::endl;
}
}
return 0;
}
-
deallog << "Face=" << f << ", boundary_id="
<< (int)triangulation.begin_active()->face(f)->boundary_id() << std::endl;
- std::set<unsigned char> no_normal_flux_boundaries;
+ std::set<types::boundary_id> no_normal_flux_boundaries;
no_normal_flux_boundaries.insert (0);
no_normal_flux_boundaries.insert (2);
VectorTools::compute_no_normal_flux_constraints
dof_handler.distribute_dofs (fe);
ConstraintMatrix constraints;
- std::set<unsigned char> no_normal_flux_boundaries;
+ std::set<types::boundary_id> no_normal_flux_boundaries;
no_normal_flux_boundaries.insert (6);
VectorTools::compute_no_normal_flux_constraints
(dof_handler, 0,
/*
5: An error occurred in line <4586> of file </scratch/deal-trunk/deal.II/include/deal.II/numerics/vector_tools.templates.h> in function
-5: void dealii::VectorTools::compute_no_normal_flux_constraints(const DoFHandlerType<dim, spacedim>&, unsigned int, const std::set<unsigned char>&, dealii::ConstraintMatrix&, const dealii::Mapping<dim, spacedim>&) [with int dim = 3; DoFHandlerType = dealii::DoFHandler; int spacedim = 3]
+5: void dealii::VectorTools::compute_no_normal_flux_constraints(const DoFHandlerType<dim, spacedim>&, unsigned int, const std::set<types::boundary_id>&, dealii::ConstraintMatrix&, const dealii::Mapping<dim, spacedim>&) [with int dim = 3; DoFHandlerType = dealii::DoFHandler; int spacedim = 3]
5: The violated condition was:
5: contribution->second.size() == dim-1
5: The name and call sequence of the exception was:
dof_handler.distribute_dofs (fe);
ConstraintMatrix constraints;
- std::set<unsigned char> no_normal_flux_boundaries;
+ std::set<types::boundary_id> no_normal_flux_boundaries;
no_normal_flux_boundaries.insert (0); // x=0
no_normal_flux_boundaries.insert (5); // z=1