unsigned int
-LogStream::depth_console (const unsigned n)
+LogStream::depth_console (const unsigned int n)
{
Threads::ThreadMutex::ScopedLock lock(log_lock);
const unsigned int h = std_depth;
unsigned int
-LogStream::depth_file (const unsigned n)
+LogStream::depth_file (const unsigned int n)
{
Threads::ThreadMutex::ScopedLock lock(log_lock);
const unsigned int h = file_depth;
const pid_t this_id = getpid();
#else
# ifdef DEAL_II_MSVC
- const unsigned this_id = 0;
+ const unsigned int this_id = 0;
# else
const pid_t this_id = 0;
# endif
long *length);
static
- unsigned (&checksum) (types<2>::forest * p4est);
+ unsigned int (&checksum) (types<2>::forest * p4est);
static
void (&vtk_write_file) (types<2>::forest * p4est,
long *length)
= p4est_connectivity_load;
- unsigned (&functions<2>::checksum) (types<2>::forest * p4est)
+ unsigned int (&functions<2>::checksum) (types<2>::forest * p4est)
= p4est_checksum;
void (&functions<2>::vtk_write_file) (types<2>::forest * p4est,
long *length);
static
- unsigned (&checksum) (types<3>::forest * p8est);
+ unsigned int (&checksum) (types<3>::forest * p8est);
static
void (&vtk_write_file) (types<3>::forest * p8est,
long *length)
= p8est_connectivity_load;
- unsigned (&functions<3>::checksum) (types<3>::forest * p8est)
+ unsigned int (&functions<3>::checksum) (types<3>::forest * p8est)
= p8est_checksum;
void (&functions<3>::vtk_write_file) (types<3>::forest * p8est,
if (f>cell->neighbor_of_neighbor (f))
smaller_idx = 1;
- unsigned larger_idx = (smaller_idx+1) % 2;
+ unsigned int larger_idx = (smaller_idx+1) % 2;
//smaller = *_list[smaller_idx]
//larger = *_list[larger_idx]
template <int dim, int spacedim>
Point<dim>
-FiniteElement<dim,spacedim>::unit_support_point (const unsigned index) const
+FiniteElement<dim,spacedim>::unit_support_point (const unsigned int index) const
{
Assert (index < this->dofs_per_cell,
ExcIndexRange (index, 0, this->dofs_per_cell));
template <int dim, int spacedim>
Point<dim-1>
-FiniteElement<dim,spacedim>::unit_face_support_point (const unsigned index) const
+FiniteElement<dim,spacedim>::unit_face_support_point (const unsigned int index) const
{
Assert (index < this->dofs_per_face,
ExcIndexRange (index, 0, this->dofs_per_face));
template <int dim, int spacedim>
const FiniteElement<dim,spacedim>&
-FiniteElement<dim,spacedim>::base_element(const unsigned index) const
+FiniteElement<dim,spacedim>::base_element(const unsigned int index) const
{
Assert (index==0, ExcIndexRange(index,0,1));
// This function should not be
* values[face*n_face_points+k](GeometryInfo<dim>::unit_normal_direction[face]+offset);
}
- const unsigned start_cell_dofs = GeometryInfo<dim>::faces_per_cell*this->dofs_per_face;
- const unsigned start_cell_points = GeometryInfo<dim>::faces_per_cell*n_face_points;
+ const unsigned int start_cell_dofs = GeometryInfo<dim>::faces_per_cell*this->dofs_per_face;
+ const unsigned int start_cell_points = GeometryInfo<dim>::faces_per_cell*n_face_points;
for (unsigned int k=0;k<interior_weights.size(0);++k)
for (unsigned int i=0;i<interior_weights.size(1);++i)
for (unsigned int d=0;d<dim;++d)
local_dofs[start_cell_dofs+i*dim+d] += interior_weights(k,i,d) * values[k+start_cell_points](d+offset);
- const unsigned start_abf_dofs = start_cell_dofs + interior_weights.size(1) * dim;
+ const unsigned int start_abf_dofs = start_cell_dofs + interior_weights.size(1) * dim;
// Cell integral of ABF terms
for (unsigned int k=0;k<interior_weights_abf.size(0);++k)
* values[GeometryInfo<dim>::unit_normal_direction[face]][face*n_face_points+k];
}
- const unsigned start_cell_dofs = GeometryInfo<dim>::faces_per_cell*this->dofs_per_face;
- const unsigned start_cell_points = GeometryInfo<dim>::faces_per_cell*n_face_points;
+ const unsigned int start_cell_dofs = GeometryInfo<dim>::faces_per_cell*this->dofs_per_face;
+ const unsigned int start_cell_points = GeometryInfo<dim>::faces_per_cell*n_face_points;
for (unsigned int k=0;k<interior_weights.size(0);++k)
for (unsigned int i=0;i<interior_weights.size(1);++i)
for (unsigned int d=0;d<dim;++d)
local_dofs[start_cell_dofs+i*dim+d] += interior_weights(k,i,d) * values[d][k+start_cell_points];
- const unsigned start_abf_dofs = start_cell_dofs + interior_weights.size(1) * dim;
+ const unsigned int start_abf_dofs = start_cell_dofs + interior_weights.size(1) * dim;
// Cell integral of ABF terms
for (unsigned int k=0;k<interior_weights_abf.size(0);++k)
* n_edge_points],
1);
- for (unsigned i = 0; i < this->degree; ++i)
+ for (unsigned int i = 0; i < this->degree; ++i)
for (unsigned int j = 0; j < this->degree-1; ++j)
system_rhs (i * (this->degree-1) + j)
+= reference_quadrature.weight (q_point) * tmp
* n_edge_points],
2);
- for (unsigned i = 0; i < this->degree; ++i)
+ for (unsigned int i = 0; i < this->degree; ++i)
for (unsigned int j = 0; j < this->degree-1; ++j)
system_rhs (i * (this->degree-1) + j)
+= boundary_weights
+ n_face_points],
2);
- for (unsigned i = 0; i <= deg; ++i)
+ for (unsigned int i = 0; i <= deg; ++i)
for (unsigned int j = 0; j < deg; ++j)
system_rhs (i * deg + j)
+= boundary_weights
* n_face_points],
2);
- for (unsigned i = 0; i <= deg; ++i)
+ for (unsigned int i = 0; i <= deg; ++i)
for (unsigned int j = 0; j < deg; ++j)
system_rhs (i * deg + j)
+= boundary_weights
* n_face_points],
2);
- for (unsigned i = 0; i <= deg; ++i)
+ for (unsigned int i = 0; i <= deg; ++i)
for (unsigned int j = 0; j < deg; ++j)
system_rhs (i * deg + j)
+= boundary_weights
* n_face_points],
1);
- for (unsigned i = 0; i <= deg; ++i)
+ for (unsigned int i = 0; i <= deg; ++i)
for (unsigned int j = 0; j < deg; ++j)
system_rhs (i * deg + j)
+= boundary_weights
* n_face_points],
1);
- for (unsigned i = 0; i <= deg; ++i)
+ for (unsigned int i = 0; i <= deg; ++i)
for (unsigned int j = 0; j < deg; ++j)
system_rhs (i * deg + j)
+= boundary_weights
* n_edge_points],
1);
- for (unsigned i = 0; i <= deg; ++i)
+ for (unsigned int i = 0; i <= deg; ++i)
for (unsigned int j = 0; j < deg; ++j)
system_rhs (i * deg + j)
+= reference_quadrature.weight (q_point) * tmp
* n_edge_points],
face_coordinates[face][1]);
- for (unsigned i = 0; i <= deg; ++i)
+ for (unsigned int i = 0; i <= deg; ++i)
for (unsigned int j = 0; j < deg; ++j)
system_rhs (i * deg + j)
+= boundary_weights (q_point + n_edge_points,
template <int dim>
-FE_Nothing<dim>::FE_Nothing (const unsigned n_components)
+FE_Nothing<dim>::FE_Nothing (const unsigned int n_components)
:
FiniteElement<dim>
(FiniteElementData<dim>(std::vector<unsigned>(dim+1,0),
* values[face*n_face_points+k](GeometryInfo<dim>::unit_normal_direction[face]+offset);
}
- const unsigned start_cell_dofs = GeometryInfo<dim>::faces_per_cell*this->dofs_per_face;
- const unsigned start_cell_points = GeometryInfo<dim>::faces_per_cell*n_face_points;
+ const unsigned int start_cell_dofs = GeometryInfo<dim>::faces_per_cell*this->dofs_per_face;
+ const unsigned int start_cell_points = GeometryInfo<dim>::faces_per_cell*n_face_points;
for (unsigned int k=0;k<interior_weights.size(0);++k)
for (unsigned int i=0;i<interior_weights.size(1);++i)
* values[GeometryInfo<dim>::unit_normal_direction[face]][face*n_face_points+k];
}
- const unsigned start_cell_dofs = GeometryInfo<dim>::faces_per_cell*this->dofs_per_face;
- const unsigned start_cell_points = GeometryInfo<dim>::faces_per_cell*n_face_points;
+ const unsigned int start_cell_dofs = GeometryInfo<dim>::faces_per_cell*this->dofs_per_face;
+ const unsigned int start_cell_points = GeometryInfo<dim>::faces_per_cell*n_face_points;
for (unsigned int k=0;k<interior_weights.size(0);++k)
for (unsigned int i=0;i<interior_weights.size(1);++i)
this->system_to_component_table.resize(this->dofs_per_cell);
this->face_system_to_component_table.resize(this->dofs_per_face);
- unsigned total_index = 0;
+ unsigned int total_index = 0;
this->block_indices_data.reinit(0,0);
for (unsigned int base=0; base < this->n_base_elements(); ++base)
vertex_number<GeometryInfo<dim>::vertices_per_cell;
++vertex_number)
{
- unsigned comp_start = 0;
+ unsigned int comp_start = 0;
for(unsigned int base=0; base<this->n_base_elements(); ++base)
for (unsigned int m=0; m<this->element_multiplicity(base);
++m, comp_start+=base_element(base).n_components())
line_number != GeometryInfo<dim>::lines_per_cell;
++line_number)
{
- unsigned comp_start = 0;
+ unsigned int comp_start = 0;
for (unsigned int base=0; base<this->n_base_elements(); ++base)
for (unsigned int m=0; m<this->element_multiplicity(base);
++m, comp_start+=base_element(base).n_components())
// 2. Lines
if (GeometryInfo<dim>::lines_per_face > 0)
- for (unsigned line_number= 0;
+ for (unsigned int line_number= 0;
line_number != GeometryInfo<dim>::lines_per_face;
++line_number)
{
- unsigned comp_start = 0;
- for(unsigned base = 0; base < this->n_base_elements(); ++base)
+ unsigned int comp_start = 0;
+ for(unsigned int base = 0; base < this->n_base_elements(); ++base)
for (unsigned int m=0; m<this->element_multiplicity(base);
++m, comp_start += base_element(base).n_components())
- for (unsigned local_index = 0;
+ for (unsigned int local_index = 0;
local_index < base_element(base).dofs_per_line;
++local_index, ++total_index)
{
// 3. Quads
if (GeometryInfo<dim>::quads_per_face > 0)
- for (unsigned quad_number= 0;
+ for (unsigned int quad_number= 0;
quad_number != GeometryInfo<dim>::quads_per_face;
++quad_number)
{
- unsigned comp_start = 0;
- for(unsigned base=0; base<this->n_base_elements(); ++base)
+ unsigned int comp_start = 0;
+ for(unsigned int base=0; base<this->n_base_elements(); ++base)
for (unsigned int m=0; m<this->element_multiplicity(base);
++m, comp_start += base_element(base).n_components())
- for (unsigned local_index = 0;
+ for (unsigned int local_index = 0;
local_index < base_element(base).dofs_per_quad;
++local_index, ++total_index)
{
vertex_number<GeometryInfo<dim>::vertices_per_cell;
++vertex_number)
{
- unsigned comp_start = 0;
+ unsigned int comp_start = 0;
for(unsigned int base=0; base<fes.size(); ++base)
for (unsigned int m=0; m<multiplicities[base];
++m, comp_start+=fes[base]->n_components())
line_number != GeometryInfo<dim>::lines_per_cell;
++line_number)
{
- unsigned comp_start = 0;
+ unsigned int comp_start = 0;
for (unsigned int base=0; base<fes.size(); ++base)
for (unsigned int m=0; m<multiplicities[base];
++m, comp_start+=fes[base]->n_components())
template <int dim, int spacedim>
Point<dim>
-FESystem<dim,spacedim>::unit_support_point (const unsigned index) const
+FESystem<dim,spacedim>::unit_support_point (const unsigned int index) const
{
Assert (index < this->dofs_per_cell,
ExcIndexRange (index, 0, this->dofs_per_cell));
template <int dim, int spacedim>
Point<dim-1>
-FESystem<dim,spacedim>::unit_face_support_point (const unsigned index) const
+FESystem<dim,spacedim>::unit_face_support_point (const unsigned int index) const
{
Assert (index < this->dofs_per_face,
ExcIndexRange (index, 0, this->dofs_per_face));
// map the unit tangentials to the
// real cell. checking for d!=dim-1
// eliminates compiler warnings
- // regarding unsigned expressions <
+ // regarding unsigned int expressions <
// 0.
for (unsigned int d=0; d!=dim-1; ++d)
{
// look at the mid-points of edges
for (; cell != endc; ++cell)
{
- for (unsigned v = 0; v < GeometryInfo<dim>::vertices_per_cell; v++)
+ for (unsigned int v = 0; v < GeometryInfo<dim>::vertices_per_cell; v++)
if (cell->vertex_index(v) == vertex)
{
// OK, we found a cell that contains
// neighbor. if this is the case, then we need to also
// add this neighbor
if (dim >= 2)
- for (unsigned vface = 0; vface < dim; vface++)
+ for (unsigned int vface = 0; vface < dim; vface++)
{
const unsigned int face =
GeometryInfo<dim>::vertex_to_face[v][vface];
// vertices used on level 0
unsigned int max_vertex_index = 0;
for (; cell!=endc; ++cell)
- for (unsigned vertex=0; vertex<GeometryInfo<dim>::vertices_per_cell; ++vertex)
+ for (unsigned int vertex=0; vertex<GeometryInfo<dim>::vertices_per_cell; ++vertex)
if (cell->vertex_index(vertex) > max_vertex_index)
max_vertex_index = cell->vertex_index(vertex);
// every time we find an adjacent
// element
for (cell=begin(); cell!=endc; ++cell)
- for (unsigned vertex=0; vertex<GeometryInfo<dim>::vertices_per_cell; ++vertex)
+ for (unsigned int vertex=0; vertex<GeometryInfo<dim>::vertices_per_cell; ++vertex)
++usage_count[cell->vertex_index(vertex)];
return std::max (GeometryInfo<dim>::vertices_per_cell,
else
{
//ghost entry
- unsigned ghostidx
+ unsigned int ghostidx
= vector.ghost_indices.index_within_set(index);
Assert(ghostidx+end-begin<(unsigned int)lsize, ExcInternalError());
typename DH<dim,spacedim>::active_cell_iterator cell, endc;
cell = endc = dof_handler.begin_active();
// (static_cast to avoid warnings
- // about unsigned always >=0)
+ // about unsigned int always >=0)
std::advance (cell, static_cast<int>(index_interval.first));
std::advance (endc, static_cast<int>(index_interval.second));
void
-TimeStepBase::wake_up (const unsigned )
+TimeStepBase::wake_up (const unsigned int )
{}
template <int dim>
void
-TimeStepBase_Tria<dim>::wake_up (const unsigned wakeup_level)
+TimeStepBase_Tria<dim>::wake_up (const unsigned int wakeup_level)
{
TimeStepBase::wake_up (wakeup_level);
template <int dim>
void
-TimeStepBase_Tria<dim>::sleep (const unsigned sleep_level)
+TimeStepBase_Tria<dim>::sleep (const unsigned int sleep_level)
{
if (sleep_level == flags.sleep_level_to_delete_grid)
{