UWE source/numerics/histogram.cc
UWE source/numerics/matrix_free.cc
UWE source/numerics/matrix_tools.cc
-source/numerics/mesh_worker.cc
-source/numerics/mesh_worker_info.cc
-source/numerics/mesh_worker_vector_selector.cc
-source/numerics/point_value_history.cc
-source/numerics/solution_transfer.cc
-source/numerics/time_dependent.cc
-source/numerics/vector_tools.cc
+UWE source/numerics/mesh_worker.cc
+UWE source/numerics/mesh_worker_info.cc
+UWE source/numerics/mesh_worker_vector_selector.cc
+UWE source/numerics/point_value_history.cc
+UWE source/numerics/solution_transfer.cc
+UWE source/numerics/time_dependent.cc
+UWE source/numerics/vector_tools.cc
include/deal.II/algorithms/newton.h
include/deal.II/algorithms/newton.templates.h
include/deal.II/algorithms/operator.h
include/deal.II/multigrid/mg_transfer.templates.h
include/deal.II/multigrid/multigrid.h
include/deal.II/multigrid/multigrid.templates.h
-include/deal.II/numerics/data_component_interpretation.h
-include/deal.II/numerics/data_out_faces.h
-include/deal.II/numerics/data_out.h
-include/deal.II/numerics/data_out_rotation.h
-include/deal.II/numerics/data_out_stack.h
-include/deal.II/numerics/data_postprocessor.h
-include/deal.II/numerics/derivative_approximation.h
-include/deal.II/numerics/dof_output_operator.h
-include/deal.II/numerics/dof_output_operator.templates.h
-include/deal.II/numerics/dof_print_solver_step.h
-include/deal.II/numerics/error_estimator.h
-include/deal.II/numerics/fe_field_function.h
-include/deal.II/numerics/fe_field_function.templates.h
-include/deal.II/numerics/histogram.h
-include/deal.II/numerics/matrix_tools.h
-include/deal.II/numerics/mesh_worker_assembler.h
-include/deal.II/numerics/mesh_worker.h
-include/deal.II/numerics/mesh_worker_info.h
-include/deal.II/numerics/mesh_worker_loop.h
-include/deal.II/numerics/mesh_worker_output.h
-include/deal.II/numerics/mesh_worker_vector_selector.h
-include/deal.II/numerics/newton.h
-include/deal.II/numerics/operator.h
-include/deal.II/numerics/point_value_history.h
-include/deal.II/numerics/solution_transfer.h
-include/deal.II/numerics/theta_timestepping.h
-include/deal.II/numerics/time_dependent.h
-include/deal.II/numerics/timestep_control.h
-include/deal.II/numerics/vector_tools.h
-include/deal.II/numerics/vector_tools.templates.h
+UWE include/deal.II/numerics/data_component_interpretation.h
+UWE include/deal.II/numerics/data_out_faces.h
+UWE include/deal.II/numerics/data_out.h
+UWE include/deal.II/numerics/data_out_rotation.h
+UWE include/deal.II/numerics/data_out_stack.h
+UWE include/deal.II/numerics/data_postprocessor.h
+UWE include/deal.II/numerics/derivative_approximation.h
+UWE include/deal.II/numerics/dof_output_operator.h
+UWE include/deal.II/numerics/dof_output_operator.templates.h
+UWE include/deal.II/numerics/dof_print_solver_step.h
+UWE include/deal.II/numerics/error_estimator.h
+UWE include/deal.II/numerics/fe_field_function.h
+UWE include/deal.II/numerics/fe_field_function.templates.h
+UWE include/deal.II/numerics/histogram.h
+UWE include/deal.II/numerics/matrix_tools.h
+UWE include/deal.II/numerics/mesh_worker_assembler.h
+UWE include/deal.II/numerics/mesh_worker.h
+UWE include/deal.II/numerics/mesh_worker_info.h
+UWE include/deal.II/numerics/mesh_worker_loop.h
+UWE include/deal.II/numerics/mesh_worker_output.h
+UWE include/deal.II/numerics/mesh_worker_vector_selector.h
+UWE include/deal.II/numerics/newton.h
+UWE include/deal.II/numerics/operator.h
+UWE include/deal.II/numerics/point_value_history.h
+UWE include/deal.II/numerics/solution_transfer.h
+UWE include/deal.II/numerics/theta_timestepping.h
+UWE include/deal.II/numerics/time_dependent.h
+UWE include/deal.II/numerics/timestep_control.h
+UWE include/deal.II/numerics/vectors.h
+UWE include/deal.II/numerics/vectors.templates.h
+UWE include/deal.II/numerics/vector_tools.h
+UWE include/deal.II/numerics/vector_tools.templates.h
// the following vector collects all rep dofs.
// the position of a rep dof within this vector
// is called rep index.
- std::vector<std::vector<unsigned int> > dofs_of_rep_points(fe.size());
+ std::vector<std::vector<types::global_dof_index> > dofs_of_rep_points(fe.size());
// the following table converts a dof i
// to the rep index.
- std::vector<std::vector<unsigned int> > dof_to_rep_index_table(fe.size());
+ std::vector<std::vector<types::global_dof_index> > dof_to_rep_index_table(fe.size());
std::vector<unsigned int> n_rep_points (fe.size(), 0);
const unsigned int max_rep_points = *std::max_element (n_rep_points.begin(),
n_rep_points.end());
- std::vector<unsigned int> dofs_on_cell (fe.max_dofs_per_cell());
+ std::vector<types::global_dof_index> dofs_on_cell (fe.max_dofs_per_cell());
std::vector<Point<DH::space_dimension> > rep_points (max_rep_points);
// get space for the values of the
Vector<double> cell_data_1(dof_1.get_fe().dofs_per_cell);
Vector<double> cell_data_2(dof_2.get_fe().dofs_per_cell);
- std::vector<short unsigned int> touch_count (dof_2.n_dofs(), 0);
- std::vector<unsigned int> local_dof_indices (dof_2.get_fe().dofs_per_cell);
+ std::vector<short unsigned int> touch_count (dof_2.n_dofs(), 0); //TODO: check on datatype... kinda strange (UK)
+ std::vector<types::global_dof_index> local_dof_indices (dof_2.get_fe().dofs_per_cell);
typename DoFHandler<dim,spacedim>::active_cell_iterator h = dof_1.begin_active();
typename DoFHandler<dim,spacedim>::active_cell_iterator l = dof_2.begin_active();
{
void
interpolate_zero_boundary_values (const dealii::DoFHandler<1> &dof_handler,
- std::map<unsigned int,double> &boundary_values)
+ std::map<types::global_dof_index,double> &boundary_values)
{
// we only need to find the
// left-most and right-most
// codimension 1
void
interpolate_zero_boundary_values (const dealii::DoFHandler<1,2> &dof_handler,
- std::map<unsigned int,double> &boundary_values)
+ std::map<types::global_dof_index,double> &boundary_values)
{
// we only need to find the
// left-most and right-most
template <int dim, int spacedim>
void
interpolate_zero_boundary_values (const dealii::DoFHandler<dim,spacedim> &dof_handler,
- std::map<unsigned int,double> &boundary_values)
+ std::map<types::global_dof_index,double> &boundary_values)
{
const FiniteElement<dim,spacedim> &fe = dof_handler.get_fe();
typename dealii::DoFHandler<dim,spacedim>::active_face_iterator
face = dof_handler.begin_active_face(),
endf = dof_handler.end_face();
- std::vector<unsigned int> face_dof_indices (fe.dofs_per_face);
+ std::vector<types::global_dof_index> face_dof_indices (fe.dofs_per_face);
for (; face!=endf; ++face)
if (face->at_boundary())
{
ExcDimensionMismatch (vec_result.size(), dof.n_dofs()));
// make up boundary values
- std::map<unsigned int,double> boundary_values;
+ std::map<types::global_dof_index,double> boundary_values;
if (enforce_zero_boundary == true)
// no need to project boundary
n_q_points = fe_values.n_quadrature_points,
n_components = fe.n_components();
- std::vector<unsigned int> dofs (dofs_per_cell);
+ std::vector<types::global_dof_index> dofs (dofs_per_cell);
Vector<double> cell_vector (dofs_per_cell);
typename DoFHandler<dim,spacedim>::active_cell_iterator
const unsigned int n_components = fe.n_components();
- std::vector<unsigned int> dofs (fe.max_dofs_per_cell());
+ std::vector<types::global_dof_index> dofs (fe.max_dofs_per_cell());
Vector<double> cell_vector (fe.max_dofs_per_cell());
typename hp::DoFHandler<dim,spacedim>::active_cell_iterator
const unsigned int dofs_per_cell = dof_handler.get_fe().dofs_per_cell;
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
cell_point.first->get_dof_indices (local_dof_indices);
for(unsigned int i=0; i<dofs_per_cell; i++)
const unsigned int dofs_per_cell = cell_point.first->get_fe().dofs_per_cell;
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
cell_point.first->get_dof_indices (local_dof_indices);
for(unsigned int i=0; i<dofs_per_cell; i++)
const unsigned int dofs_per_cell = dof_handler.get_fe().dofs_per_cell;
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
cell_point.first->get_dof_indices (local_dof_indices);
for(unsigned int i=0; i<dofs_per_cell; i++)
const unsigned int dofs_per_cell = cell_point.first->get_fe().dofs_per_cell;
- std::vector<unsigned int> local_dof_indices (dofs_per_cell);
+ std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
cell_point.first->get_dof_indices (local_dof_indices);
for(unsigned int i=0; i<dofs_per_cell; i++)
n_q_points = fe_values.n_quadrature_points,
n_components = fe.n_components();
- std::vector<unsigned int> dofs (dofs_per_cell);
+ std::vector<types::global_dof_index> dofs (dofs_per_cell);
Vector<double> cell_vector (dofs_per_cell);
typename DoFHandler<dim,spacedim>::active_cell_iterator cell = dof_handler.begin_active(),
const unsigned int n_components = fe.n_components();
- std::vector<unsigned int> dofs (fe.max_dofs_per_cell());
+ std::vector<types::global_dof_index> dofs (fe.max_dofs_per_cell());
Vector<double> cell_vector (fe.max_dofs_per_cell());
typename hp::DoFHandler<dim,spacedim>::active_cell_iterator
void interpolate_boundary_values (const Mapping<DH::dimension, DH::space_dimension> &,
const DH &dof,
const typename FunctionMap<DH::space_dimension>::type &function_map,
- std::map<unsigned int,double> &boundary_values,
+ std::map<types::global_dof_index,double> &boundary_values,
const std::vector<bool> &component_mask_,
const dealii::internal::int2type<1>)
{
interpolate_boundary_values (const Mapping<DH::dimension, DH::space_dimension> &mapping,
const DH &dof,
const typename FunctionMap<DH::space_dimension>::type &function_map,
- std::map<unsigned int,double> &boundary_values,
+ std::map<types::global_dof_index,double> &boundary_values,
const std::vector<bool> &component_mask_,
const dealii::internal::int2type<DH::dimension>)
{
ExcNoComponentSelected());
// field to store the indices
- std::vector<unsigned int> face_dofs;
+ std::vector<types::global_dof_index> face_dofs;
face_dofs.reserve (DoFTools::max_dofs_per_face(dof));
std::vector<Point<spacedim> > dof_locations;
interpolate_boundary_values (const Mapping<DH::dimension, DH::space_dimension> &mapping,
const DH &dof,
const typename FunctionMap<DH::space_dimension>::type &function_map,
- std::map<unsigned int,double> &boundary_values,
+ std::map<types::global_dof_index,double> &boundary_values,
const std::vector<bool> &component_mask_)
{
internal::
const DH &dof,
const types::boundary_id_t boundary_component,
const Function<DH::space_dimension> &boundary_function,
- std::map<unsigned int,double> &boundary_values,
+ std::map<types::global_dof_index,double> &boundary_values,
const std::vector<bool> &component_mask)
{
typename FunctionMap<DH::space_dimension>::type function_map;
interpolate_boundary_values (const DH &dof,
const types::boundary_id_t boundary_component,
const Function<DH::space_dimension> &boundary_function,
- std::map<unsigned int,double> &boundary_values,
+ std::map<types::global_dof_index,double> &boundary_values,
const std::vector<bool> &component_mask)
{
Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
void
interpolate_boundary_values (const DH &dof,
const typename FunctionMap<DH::space_dimension>::type &function_map,
- std::map<unsigned int,double> &boundary_values,
+ std::map<types::global_dof_index,double> &boundary_values,
const std::vector<bool> &component_mask)
{
Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
ConstraintMatrix &constraints,
const std::vector<bool> &component_mask_)
{
- std::map<unsigned int,double> boundary_values;
+ std::map<types::global_dof_index,double> boundary_values;
interpolate_boundary_values (mapping, dof, function_map,
boundary_values, component_mask_);
- std::map<unsigned int,double>::const_iterator boundary_value =
+ std::map<types::global_dof_index,double>::const_iterator boundary_value =
boundary_values.begin();
for ( ; boundary_value !=boundary_values.end(); ++boundary_value)
{
const DoFHandler<1,1> &dof,
const FunctionMap<1>::type &boundary_functions,
const Quadrature<0> &,
- std::map<unsigned int,double> &boundary_values,
+ std::map<types::global_dof_index,double> &boundary_values,
std::vector<unsigned int> component_mapping)
{
Assert (component_mapping.size() == 0, ExcNotImplemented());
const DoFHandler<1,2> &dof,
const FunctionMap<2>::type &boundary_functions,
const Quadrature<0> &,
- std::map<unsigned int,double> &boundary_values,
+ std::map<types::global_dof_index,double> &boundary_values,
std::vector<unsigned int> component_mapping)
{
Assert (component_mapping.size() == 0, ExcNotImplemented());
const DoFHandler<dim, spacedim>&dof,
const typename FunctionMap<spacedim>::type &boundary_functions,
const Quadrature<dim-1> &q,
- std::map<unsigned int,double> &boundary_values,
+ std::map<types::global_dof_index,double> &boundary_values,
std::vector<unsigned int> component_mapping)
{
//TODO:[?] In project_boundary_values, no condensation of sparsity
else
AssertDimension (dof.get_fe().n_components(), component_mapping.size());
- std::vector<unsigned int> dof_to_boundary_mapping;
+ std::vector<types::global_dof_index> dof_to_boundary_mapping;
std::set<types::boundary_id_t> selected_boundary_components;
for (typename FunctionMap<spacedim>::type::const_iterator i=boundary_functions.begin();
i!=boundary_functions.end(); ++i)
project_boundary_values (const DoFHandler<dim,spacedim> &dof,
const typename FunctionMap<spacedim>::type &boundary_functions,
const Quadrature<dim-1> &q,
- std::map<unsigned int,double> &boundary_values,
+ std::map<types::global_dof_index,double> &boundary_values,
std::vector<unsigned int> component_mapping)
{
Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
ConstraintMatrix &constraints,
std::vector<unsigned int> component_mapping)
{
- std::map<unsigned int,double> boundary_values;
+ std::map<types::global_dof_index,double> boundary_values;
project_boundary_values (mapping, dof, boundary_functions, q,
boundary_values, component_mapping);
- std::map<unsigned int,double>::const_iterator boundary_value =
+ std::map<types::global_dof_index,double>::const_iterator boundary_value =
boundary_values.begin();
for ( ; boundary_value !=boundary_values.end(); ++boundary_value)
{
template <int dim>
struct VectorDoFTuple
{
- unsigned int dof_indices[dim];
+ types::global_dof_index dof_indices[dim];
VectorDoFTuple ()
{
// vector t is largest by
// magnitude, then
// x1=t[1]/t[0]*x_0, etc.
- unsigned int largest_component = 0;
+ types::global_dof_index largest_component = 0;
for (unsigned int d=1; d<dim; ++d)
if (std::fabs(tangent_vector[d]) > std::fabs(tangent_vector[largest_component]) + 1e-10)
largest_component = d;
update_quadrature_points |
update_values);
std::vector<double> dof_values;
- std::vector<unsigned int> face_dof_indices;
+ std::vector<types::global_dof_index> face_dof_indices;
typename hp::DoFHandler<dim>::active_cell_iterator cell = dof_handler.begin_active ();
switch (dim)
* fe_values[vec].value (fe.face_to_cell_index (i, face), q_point));
}
- std::vector<unsigned int> face_dof_indices (fe.dofs_per_face);
+ std::vector<types::global_dof_index> face_dof_indices (fe.dofs_per_face);
cell->face (face)->get_dof_indices (face_dof_indices, cell->active_fe_index ());
const Function<3>& boundary_function,
const std::vector<DerivativeForm<1,3,3> >& jacobians,
std::vector<double>& dof_values,
- std::vector<unsigned int>& projected_dofs)
+ std::vector<types::global_dof_index>& projected_dofs)
{
// Compute the intergral over
// the product of the normal
* fe_values[vec].value (fe.face_to_cell_index (i, face), q_point));
}
- std::vector<unsigned int> face_dof_indices (fe.dofs_per_face);
+ std::vector<types::global_dof_index> face_dof_indices (fe.dofs_per_face);
cell->face (face)->get_dof_indices (face_dof_indices, cell->active_fe_index ());
// compute a second one.
const unsigned int& n_dofs = dof_handler.n_dofs ();
std::vector<double> dof_values (n_dofs);
- std::vector<unsigned int> projected_dofs (n_dofs);
+ std::vector<types::global_dof_index> projected_dofs (n_dofs);
for (unsigned int dof = 0; dof < n_dofs; ++dof)
projected_dofs[dof] = 0;
{
const unsigned int& n_dofs = dof_handler.n_dofs ();
std::vector<double> dof_values (n_dofs);
- std::vector<unsigned int> projected_dofs (n_dofs);
+ std::vector<types::global_dof_index> projected_dofs (n_dofs);
for (unsigned int dof = 0; dof < n_dofs; ++dof)
projected_dofs[dof] = 0;
"to imposing Dirichlet values on the vector-valued "
"quantity."));
- std::vector<unsigned int> face_dofs;
+ std::vector<types::global_dof_index> face_dofs;
// create FE and mapping
// collections for all elements in