47 scatter_to_seq_(nullptr),
58 switch (cell->
dim()) {
60 return fe<1>(cell)->
n_dofs();
63 return fe<2>(cell)->
n_dofs();
66 return fe<3>(cell)->
n_dofs();
77 return fe<1>(cell)->dof(idof);
80 return fe<2>(cell)->dof(idof);
83 return fe<3>(cell)->dof(idof);
122 unsigned int n_node_dofs = 0;
126 node_dof_starts.push_back(n_node_dofs);
127 n_node_dofs +=
ds_->n_node_dofs(nid);
129 node_dof_starts.push_back(n_node_dofs);
138 for (
unsigned int n=0; n<cell.dim()+1; n++)
150 for (
unsigned int n=0; n<cell.dim()+1; n++)
174 unsigned int n_dofs_sum = 0;
175 for (
auto nd : n_dofs) n_dofs_sum += nd;
176 dofs.resize(n_dofs_sum);
184 unsigned int n_elems;
212 unsigned int dof_offset=0;
213 for (
unsigned int gid=0; gid<
ghost_proc_el[proc].size(); gid++)
218 for (
unsigned dof=0; dof<
n_dofs(cell); dof++)
222 for (
unsigned int idof = 0; idof<
n_dofs(cell); ++idof)
229 if (node_dofs[node_dof_starts[nid]+loc_node_dof_count[dof_nface_idx]] ==
INVALID_DOF)
230 node_dofs[node_dof_starts[nid]+loc_node_dof_count[dof_nface_idx]] = dofs[dof_offset+idof];
232 loc_node_dof_count[dof_nface_idx]++;
236 dof_offset +=
n_dofs(cell);
242 if (!update_cells[cell.local_idx()])
continue;
246 for (
unsigned int idof = 0; idof<cell.n_dofs(); ++idof)
248 if (cell.cell_dof(idof).dim == 0)
250 unsigned int dof_nface_idx = cell.cell_dof(idof).n_face_idx;
256 loc_node_dof_count[dof_nface_idx]++;
266 OLD_ASSERT(
ds_ ==
nullptr,
"Attempt to distribute DOFs multiple times!");
273 unsigned int next_free_dof = 0;
277 node_dofs.resize(node_dof_starts[node_dof_starts.size()-1]);
288 for (
unsigned int idof = 0; idof<cell.n_dofs(); ++idof)
290 unsigned int dof_dim = cell.cell_dof(idof).dim;
291 unsigned int dof_nface_idx = cell.cell_dof(idof).n_face_idx;
296 unsigned int node_dof_idx = node_dof_starts[nid]+loc_node_dof_count[dof_nface_idx];
298 switch (node_status[nid])
301 for (
int i=0; i<node_dof_starts[nid+1] - node_dof_starts[nid]; i++)
304 node_dofs[node_dof_starts[nid]+i] = next_free_dof++;
310 update_cells[cell.local_idx()] =
true;
314 loc_node_dof_count[dof_nface_idx]++;
316 else if (dof_dim == cell.dim())
323 ASSERT(
false).error(
"Unsupported dof n_face.");
331 dof_ds_ = std::make_shared<Distribution>(
lsize_, PETSC_COMM_WORLD);
343 for (
unsigned int from_higher = 0; from_higher < 2; from_higher++)
347 if ((proc >
el_ds_->
myp()) == from_higher)
355 for (
auto dof : dofs)
362 update_cells.clear();
364 node_dof_starts.clear();
370 if (
dh_seq_ !=
nullptr)
return;
374 dh_seq_ = std::make_shared<DOFHandlerMultiDim>(*this);
378 dh_seq_ = std::make_shared<DOFHandlerMultiDim>(*mesh_);
406 cell_starts_loc[
row_4_el[cell.elm_idx()]+1] = cell.n_dofs();
408 for (
unsigned int i=0; i<mesh_->n_elements(); ++i)
409 cell_starts_loc[i+1] += cell_starts_loc[i];
412 dof_indices_loc.resize(cell_starts_loc[mesh_->n_elements()]);
415 for (
unsigned int idof=0; idof<cell.n_dofs(); idof++)
420 dh_seq_->cell_starts.resize(mesh_->n_elements()+1);
425 cell_starts_loc.size(),
431 dof_indices_loc.size(),
434 (
const int *)
distr.get_lsizes_array(),
435 (
const int *)
distr.get_starts_array(),
441 VecCreateMPI(PETSC_COMM_WORLD,
lsize_, PETSC_DETERMINE, &v_from);
449 dh_seq_->scatter_to_seq_ = std::make_shared<VecScatter>();
450 VecScatterCreateToAll(v_seq,
dh_seq_->scatter_to_seq_.get(), NULL);
458 unsigned int ndofs = 0;
460 for (
unsigned int k=0; k<ndofs; k++)
470 unsigned int ndofs = 0;
472 for (
unsigned int k=0; k<ndofs; k++)
492 for (
unsigned int iedg=0; iedg<
mesh_->
n_edges(); iedg++)
494 bool is_edge_local =
false;
496 for (
int sid=0; sid<edg->
n_sides; sid++)
499 is_edge_local =
true;
520 for (
unsigned int nid=0; nid<cell.elm()->n_nodes(); nid++)
524 if (node_is_local[nid])
532 bool has_local_node =
false;
534 for (
unsigned int nid=0; nid<cell->n_nodes(); nid++)
537 has_local_node =
true;
580 auto bgn_it = make_iter<DHCellAccessor>(
DHCellAccessor(
this, 0) );
587 auto bgn_it = make_iter<DHCellAccessor>(
DHCellAccessor(
this, 0) );
#define MPI_Recv(buf, count, datatype, source, tag, comm, status)
void receive_ghost_dofs(unsigned int proc, std::vector< LongIdx > &dofs)
Obtain dof numbers on ghost elements from other processor.
int LongIdx
Define type that represents indices of large arrays (elements, nodes, dofs etc.)
std::shared_ptr< DOFHandlerMultiDim > sequential()
Returns sequential version of the current dof handler.
virtual ~DOFHandlerBase()
Destructor.
void create_sequential()
Communicate local dof indices to all processors and create new sequential dof handler.
void init_cell_starts()
Initialize vector of starting indices for elements.
Declaration of class which handles the ordering of degrees of freedom (dof) and mappings between loca...
LongIdx * el_4_loc
Local element index -> global element index.
unsigned int get_loc_dof_indices(const ElementAccessor< 3 > &cell, std::vector< LongIdx > &indices) const override
Returns the indices of dofs associated to the cell on the local process.
LongIdx * get_row_4_el() const
const std::vector< MeshObject > & objects(unsigned int dim) const
Distribution * el_ds_
Distribution of elements.
unsigned int dim
Association to n-face of given dimension (point, line, triangle, tetrahedron.
void distribute_dofs(std::shared_ptr< DiscreteSpace > ds)
Distributes degrees of freedom on the mesh needed for the given discrete space.
std::shared_ptr< VecScatter > sequential_scatter()
Returns scatter context from parallel to sequential vectors.
std::vector< LongIdx > local_to_global_dof_idx_
Maps local and ghost dof indices to global ones.
#define MPI_Send(buf, count, datatype, dest, tag, comm)
#define ASSERT(expr)
Allow use shorter versions of macro names if these names is not used with external library...
std::shared_ptr< Distribution > dof_ds_
Distribution of dofs associated to local process.
#define MPI_Allgatherv(sendbuf, sendcount, sendtype, recvbuf, recvcounts, displs, recvtype, comm)
void update_local_dofs(unsigned int proc, const std::vector< bool > &update_cells, const std::vector< LongIdx > &dofs, const std::vector< LongIdx > &node_dof_starts, std::vector< LongIdx > &node_dofs)
Update dofs on local elements from ghost element dofs.
ElementAccessor< 3 > element() const
std::shared_ptr< DOFHandlerMultiDim > dh_seq_
Sequential dof handler associated to the current (parallel) one.
unsigned int lsize_
Number of dofs associated to local process.
virtual ElementAccessor< 3 > element_accessor(unsigned int idx) const
Create and return ElementAccessor to element of given idx.
unsigned int n_face_idx
Index of n-face to which the dof is associated.
unsigned int n_dofs(ElementAccessor< 3 > cell) const
Return number of dofs on given cell.
map< unsigned int, vector< LongIdx > > ghost_proc_el
Arrays of ghost cells for each neighbouring processor.
void send_ghost_dofs(unsigned int proc)
Send dof numbers to other processor.
void init_node_status(std::vector< short int > &node_status)
Initialize node_status.
std::vector< LongIdx > cell_starts
Starting indices for element dofs.
unsigned int n_vb_neighbours() const
ElementAccessor< 3 > element()
static const int VALID_NODE
unsigned int get_dof_indices(const ElementAccessor< 3 > &cell, std::vector< LongIdx > &indices) const override
Returns the global indices of dofs associated to the cell.
bool is_local(unsigned int idx) const
identify local index
Mesh * mesh_
Pointer to the mesh to which the dof handler is associated.
unsigned int begin(int proc) const
get starting local index
std::vector< LongIdx > dof_indices
Dof numbers on local and ghost elements.
Range< DHCellAccessor > ghost_range() const
Returns range over ghosts DOF handler cells.
vector< LongIdx > nb_4_loc
Local neighbour index -> global neighbour index.
unsigned int max_elem_dofs_
Max. number of dofs per element.
vector< LongIdx > ghost_4_loc
Indices of ghost cells (neighbouring with local elements).
virtual Range< ElementAccessor< 3 > > elements_range() const
Returns range of bulk elements.
unsigned int n_nodes() const
void init_node_dof_starts(std::vector< LongIdx > &node_dof_starts)
Initialize auxiliary vector of starting indices of nodal dofs.
static const int ASSIGNED_NODE
Distribution * get_el_ds() const
void make_elem_partitioning()
Prepare parallel distribution of elements, edges and neighbours.
static const int INVALID_NODE
std::shared_ptr< Distribution > distr() const
unsigned int myp() const
get my processor
Support classes for parallel programing.
#define MPI_Allreduce(sendbuf, recvbuf, count, datatype, op, comm)
vector< Neighbour > vb_neighbours_
#define MPI_STATUS_IGNORE
vector< LongIdx > edg_4_loc
Local edge index -> global edge index.
virtual unsigned int n_elements(bool boundary=false) const
Returns count of boundary or bulk elements.
Range< DHCellAccessor > own_range() const
Returns range of DOF handler cells (only range of own without ghost cells)
unsigned int loffset_
Index of the first dof on the local process.
static const int INVALID_DOF
const Dof & cell_dof(ElementAccessor< 3 > cell, unsigned int idof) const
Return dof on a given cell.
set< unsigned int > ghost_proc
Processors of ghost elements.
~DOFHandlerMultiDim() override
Destructor.
vector< LongIdx > node_4_loc
Indices of local nodes in mesh tree.
std::vector< Edge > edges
Vector of MH edges, this should not be part of the geometrical mesh.
std::shared_ptr< DiscreteSpace > ds_
Pointer to the discrete space for which the handler distributes dofs.
Abstract class for description of finite elements.
unsigned int n_global_dofs_
Number of global dofs assigned by the handler.
unsigned int n_edges() const
bool el_is_local(int index) const
DOFHandlerMultiDim(Mesh &_mesh, bool make_elem_part=true)
Constructor.
Range< DHCellAccessor > local_range() const
Returns range over own and ghost cells of DOF handler.
const std::vector< unsigned int > & obj_4_el() const
bool is_parallel_
Indicator for parallel/sequential dof handler.
unsigned int idx() const
Return local idx of element in boundary / bulk part of element vector.
DHCellAccessor cell_accessor_from_element(unsigned int elm_idx) const
Return DHCellAccessor appropriate to ElementAccessor of given idx.
std::shared_ptr< VecScatter > scatter_to_seq_
Scatter context for parallel to sequential vectors.
LongIdx * get_el_4_loc() const
LongIdx * row_4_el
Global element index -> index according to partitioning.
SideIter side(const unsigned int i) const
Implementation of range helper class.
friend class DHCellAccessor
std::size_t hash() const override
unsigned int lsize(int proc) const
get local size