17#ifndef dealii_mesh_worker_local_results_h
18#define dealii_mesh_worker_local_results_h
222 template <
typename number>
292 matrix(
const unsigned int i,
const bool external =
false);
301 matrix(
const unsigned int i,
const bool external =
false)
const;
356 template <
typename MatrixType>
368 template <
typename MatrixType>
388 template <
class StreamType>
402 std::vector<number>
J;
408 std::vector<BlockVector<number>>
R;
414 std::vector<MatrixBlock<FullMatrix<number>>>
M1;
422 std::vector<MatrixBlock<FullMatrix<number>>>
M2;
432 template <
typename number>
440 template <
typename number>
448 template <
typename number>
449 template <
typename MatrixType>
455 M1.resize(matrices.
size());
457 M2.resize(matrices.
size());
458 for (
unsigned int i = 0; i < matrices.
size(); ++i)
460 const unsigned int row = matrices.
block(i).
row;
474 template <
typename number>
475 template <
typename MatrixType>
481 M1.resize(matrices.
size());
483 M2.resize(matrices.
size());
484 for (
unsigned int i = 0; i < matrices.
size(); ++i)
487 const unsigned int row = o[o.
min_level()].row;
488 const unsigned int col = o[o.
min_level()].column;
501 template <
typename number>
509 for (
unsigned int i = 0; i < n; ++i)
522 template <
typename number>
525 const unsigned int nv)
527 quadrature_data.reinit(np, nv);
531 template <
typename number>
539 template <
typename number>
547 template <
typename number>
555 template <
typename number>
559 return quadrature_data.n_rows();
563 template <
typename number>
567 return quadrature_data.n_cols();
571 template <
typename number>
580 template <
typename number>
589 template <
typename number>
603 template <
typename number>
606 const unsigned int i)
608 return quadrature_data(k, i);
612 template <
typename number>
616 return quadrature_data;
620 template <
typename number>
629 template <
typename number>
638 template <
typename number>
652 template <
typename number>
655 const unsigned int i)
const
657 return quadrature_data(k, i);
661 template <
typename number>
662 template <
class StreamType>
666 os <<
"J: " << J.size() << std::endl;
667 os <<
"R: " << R.size() << std::endl;
668 for (
unsigned int i = 0; i < R.size(); ++i)
670 os <<
" " << R[i].n_blocks() <<
" -";
671 for (
unsigned int j = 0; j < R[i].n_blocks(); ++j)
672 os <<
' ' << R[i].block(j).size();
675 os <<
"M: " << M1.size() <<
" face " << M2.size() << std::endl;
676 for (
unsigned int i = 0; i < M1.size(); ++i)
678 os <<
" " << M1[i].row <<
',' << M1[i].column <<
' '
679 << M1[i].matrix.m() <<
'x' << M1[i].matrix.n();
681 os <<
" face " << M2[i].row <<
',' << M2[i].column <<
' '
682 << M2[i].matrix.m() <<
'x' << M2[i].matrix.n();
unsigned int min_level() const
const value_type & block(size_type i) const
unsigned int size() const
unsigned int size() const
Number of stored data objects.
const value_type & block(size_type i) const
MatrixBlock< FullMatrix< number > > & matrix(const unsigned int i, const bool external=false)
unsigned int n_quadrature_values() const
BlockVector< number > & vector(const unsigned int i)
unsigned int n_vectors() const
number & quadrature_value(const unsigned int k, const unsigned int i)
number value(const unsigned int i) const
std::vector< BlockVector< number > > R
std::size_t memory_consumption() const
const BlockVector< number > & vector(const unsigned int i) const
const MatrixBlock< FullMatrix< number > > & matrix(const unsigned int i, const bool external=false) const
number quadrature_value(const unsigned int k, const unsigned int i) const
Table< 2, number > quadrature_data
void initialize_matrices(const MatrixBlockVector< MatrixType > &matrices, bool both)
void initialize_matrices(const MGMatrixBlockVector< MatrixType > &matrices, bool both)
std::vector< MatrixBlock< FullMatrix< number > > > M2
void reinit(const BlockIndices &local_sizes)
void initialize_matrices(const unsigned int n, bool both)
std::vector< MatrixBlock< FullMatrix< number > > > M1
unsigned int n_values() const
void initialize_quadrature(const unsigned int np, const unsigned int nv)
Table< 2, number > & quadrature_values()
void initialize_numbers(const unsigned int n)
void initialize_vectors(const unsigned int n)
unsigned int n_matrices() const
void print_debug(StreamType &os) const
unsigned int n_quadrature_points() const
number & value(const unsigned int i)
#define DEAL_II_NAMESPACE_OPEN
#define DEAL_II_NAMESPACE_CLOSE
#define AssertIndexRange(index, range)