17 #ifndef dealii__mesh_worker_output_h 18 #define dealii__mesh_worker_output_h 20 #include <deal.II/meshworker/dof_info.h> 21 #include <deal.II/base/smartpointer.h> 22 #include <deal.II/base/utilities.h> 23 #include <deal.II/lac/block_vector.h> 24 #include <deal.II/base/mg_level_object.h> 27 DEAL_II_NAMESPACE_OPEN
112 void write(
const T &t)
const;
138 template <
typename T>
153 deallog << std::endl;
168 const unsigned int nv)
201 const unsigned int row_length =
n_points;
205 const unsigned int row_length2 = (patch_dim==1) ? row_length : (row_length*row_length);
211 for (
unsigned int k=0; k<np; ++k)
213 if (k % row_length == 0)
215 if (k % row_length2 == 0)
218 for (
unsigned int i=0; i<nv; ++i)
238 DEAL_II_NAMESPACE_CLOSE
static const unsigned int invalid_unsigned_int
#define AssertDimension(dim1, dim2)
unsigned int n_quadrature_values() const
void assemble(const DoFInfo< dim > &info)
void initialize_quadrature(unsigned int np, unsigned int nv)
number & quadrature_value(unsigned int k, unsigned int i)
void write(const T &t) const
void initialize_info(DoFInfo< dim > &info, bool face)
void initialize(const unsigned int n_points, const unsigned int n_vectors)
void initialize_stream(std::ostream &stream)
unsigned int n_quadrature_points() const