library to the muparser library after the deal.II 8.1 release).
- DoFRenumbering::downstream_dg.
- DoFTools::count_dofs_per_component.
+ - DoFTools::make_sparsity_pattern with a vector-of-vector mask.
</ol>
<li> Removed: The config.h file no longer exports HAVE_* definitions.
const bool keep_constrained_dofs = true,
const types::subdomain_id subdomain_id = numbers::invalid_subdomain_id);
- /**
- * @deprecated This is the old form of the previous function. It generates a
- * table of DoFTools::Coupling values (where a <code>true</code> value in
- * the mask is translated into a Coupling::always value in the table) and
- * calls the function above.
- */
- template <class DH, class SparsityPattern>
- void
- make_sparsity_pattern (const DH &dof,
- const std::vector<std::vector<bool> > &mask,
- SparsityPattern &sparsity_pattern) DEAL_II_DEPRECATED;
-
/**
* Construct a sparsity pattern that allows coupling degrees of freedom on
* two different but related meshes.
}
- template <class DH, class SparsityPattern>
- inline
- void
- make_sparsity_pattern (const DH &dof,
- const std::vector<std::vector<bool> > &mask,
- SparsityPattern &sparsity_pattern)
- {
- const unsigned int ncomp = dof.get_fe().n_components();
-
- Assert (mask.size() == ncomp,
- ExcDimensionMismatch(mask.size(), ncomp));
- for (unsigned int i=0; i<mask.size(); ++i)
- Assert (mask[i].size() == ncomp,
- ExcDimensionMismatch(mask[i].size(), ncomp));
- // Create a coupling table out of the mask
- Table<2,DoFTools::Coupling> couplings(ncomp, ncomp);
- for (unsigned int i=0; i<ncomp; ++i)
- for (unsigned int j=0; j<ncomp; ++j)
- if (mask[i][j])
- couplings(i,j) = always;
- else
- couplings(i,j) = none;
-
- // Call the new function
- make_sparsity_pattern(dof, couplings, sparsity_pattern);
- }
-
-
template <class DH, class Comp>
void
map_support_points_to_dofs (
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2013 by the deal.II authors
+// Copyright (C) 2003 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// check
// DoFTools::
// make_sparsity_pattern (const DoFHandler<dim> &,
-// std::vector<std::vector<bool> > &,
+// Table<2,DoFTools::Coupling> &,
// SparsityPattern &);
{
// set up X-shape mask
const unsigned int n_components = dof_handler.get_fe().n_components();
- std::vector<std::vector<bool> > mask (n_components,
- std::vector<bool>(n_components,false));
+ Table<2,DoFTools::Coupling> mask (n_components, n_components);
for (unsigned int i=0; i<n_components; ++i)
- mask[i][i] = mask[i][n_components-i-1] = true;
+ for (unsigned int j=0; j<n_components; ++j)
+ mask(i,j) = DoFTools::none;
+ for (unsigned int i=0; i<n_components; ++i)
+ mask[i][i] = mask[i][n_components-i-1] = DoFTools::always;
// create sparsity pattern
SparsityPattern sp (dof_handler.n_dofs(),
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2013 by the deal.II authors
+// Copyright (C) 2003 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// check
// DoFTools::
// make_sparsity_pattern (const DoFHandler<dim> &,
-// std::vector<std::vector<bool> > &,
+// Table<2,DoFTools::Coupling> &,
// SparsityPattern &,
// ConstraintMatrix,
// true);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2013 by the deal.II authors
+// Copyright (C) 2003 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// check
// DoFTools::
// make_sparsity_pattern (const DoFHandler<dim> &,
-// std::vector<std::vector<bool> > &,
+// Table<2,Coupling> &,
// CompressedSparsityPattern &);
std::string output_file_name = "output";
{
// set up X-shape mask
const unsigned int n_components = dof_handler.get_fe().n_components();
- std::vector<std::vector<bool> > mask (n_components,
- std::vector<bool>(n_components,false));
+ Table<2,DoFTools::Coupling> mask (n_components, n_components);
for (unsigned int i=0; i<n_components; ++i)
- mask[i][i] = mask[i][n_components-i-1] = true;
+ for (unsigned int j=0; j<n_components; ++j)
+ mask(i,j) = DoFTools::none;
+ for (unsigned int i=0; i<n_components; ++i)
+ mask[i][i] = mask[i][n_components-i-1] = DoFTools::always;
// create sparsity pattern
CompressedSparsityPattern sp (dof_handler.n_dofs());
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2013 by the deal.II authors
+// Copyright (C) 2003 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
// set up X-shape mask
const unsigned int n_components = dof_handler.get_fe().n_components();
- std::vector<std::vector<bool> > mask (n_components,
- std::vector<bool>(n_components,false));
+ Table<2,DoFTools::Coupling> mask (n_components, n_components);
for (unsigned int i=0; i<n_components; ++i)
- mask[i][i] = mask[i][n_components-i-1] = true;
+ for (unsigned int j=0; j<n_components; ++j)
+ mask(i,j) = DoFTools::none;
+ for (unsigned int i=0; i<n_components; ++i)
+ mask[i][i] = mask[i][n_components-i-1] = DoFTools::always;
// create sparsity pattern
CompressedSetSparsityPattern sp (dof_handler.n_dofs());
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2013 by the deal.II authors
+// Copyright (C) 2003 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// check
// DoFTools::
// make_sparsity_pattern (const DoFHandler<dim> &,
-// std::vector<std::vector<bool> > &,
+// Table<2,Coupling> &,
// BlockSparsityPattern &);
std::string output_file_name = "output";
{
// set up X-shape mask
const unsigned int n_components = dof_handler.get_fe().n_components();
- std::vector<std::vector<bool> > mask (n_components,
- std::vector<bool>(n_components,false));
+ Table<2,DoFTools::Coupling> mask (n_components, n_components);
for (unsigned int i=0; i<n_components; ++i)
- mask[i][i] = mask[i][n_components-i-1] = true;
+ for (unsigned int j=0; j<n_components; ++j)
+ mask(i,j) = DoFTools::none;
+ for (unsigned int i=0; i<n_components; ++i)
+ mask[i][i] = mask[i][n_components-i-1] = DoFTools::always;
// we split up the matrix into
// blocks according to the number
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2013 by the deal.II authors
+// Copyright (C) 2003 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
{
// set up X-shape mask
const unsigned int n_components = dof_handler.get_fe().n_components();
- std::vector<std::vector<bool> > mask (n_components,
- std::vector<bool>(n_components,false));
+ Table<2,DoFTools::Coupling> mask (n_components, n_components);
for (unsigned int i=0; i<n_components; ++i)
- mask[i][i] = mask[i][n_components-i-1] = true;
+ for (unsigned int j=0; j<n_components; ++j)
+ mask(i,j) = DoFTools::none;
+ for (unsigned int i=0; i<n_components; ++i)
+ mask[i][i] = mask[i][n_components-i-1] = DoFTools::always;
// we split up the matrix into
// blocks according to the number
// ---------------------------------------------------------------------
//
-// Copyright (C) 2003 - 2013 by the deal.II authors
+// Copyright (C) 2003 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// check
// DoFTools::
// make_sparsity_pattern (const DoFHandler<dim> &,
-// std::vector<std::vector<bool> > &,
+// Table<2,Coupling> &,
// BlockCompressedSetSparsityPattern &);
std::string output_file_name = "output";
{
// set up X-shape mask
const unsigned int n_components = dof_handler.get_fe().n_components();
- std::vector<std::vector<bool> > mask (n_components,
- std::vector<bool>(n_components,false));
+ Table<2,DoFTools::Coupling> mask (n_components, n_components);
for (unsigned int i=0; i<n_components; ++i)
- mask[i][i] = mask[i][n_components-i-1] = true;
+ for (unsigned int j=0; j<n_components; ++j)
+ mask(i,j) = DoFTools::none;
+ for (unsigned int i=0; i<n_components; ++i)
+ mask[i][i] = mask[i][n_components-i-1] = DoFTools::always;
// we split up the matrix into
// blocks according to the number
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different blocks should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (dim*2,
- std::vector<bool>(dim*2, false));
+ const unsigned int n_components = 2*dim;
+ Table<2,DoFTools::Coupling> mask (n_components, n_components);
+ for (unsigned int i=0; i<n_components; ++i)
+ for (unsigned int j=0; j<n_components; ++j)
+ mask(i,j) = DoFTools::none;
for (unsigned int i=0; i<dim; ++i)
for (unsigned int j=0; j<dim; ++j)
- mask[i][j] = true;
+ mask[i][j] = DoFTools::always;
for (unsigned int i=0; i<dim; ++i)
for (unsigned int j=0; j<dim; ++j)
- mask[dim+i][dim+j] = true;
+ mask[dim+i][dim+j] = DoFTools::always;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// create sparsity pattern. note
// that different components should
// not couple, so use pattern
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
//--------------- Regular sparsity pattern checks -----------------
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// create sparsity pattern. note
// that different components should
// not couple, so use pattern
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
//--------------- Regular sparsity pattern checks -----------------
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// create sparsity pattern. note
// that different components should
// not couple, so use pattern
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
//--------------- Regular sparsity pattern checks -----------------
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// create sparsity pattern. note
// that different components should
// not couple, so use pattern
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
//--------------- Regular sparsity pattern checks -----------------
// ---------------------------------------------------------------------
//
-// Copyright (C) 2001 - 2013 by the deal.II authors
+// Copyright (C) 2001 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// for the stokes equation the
// pressure does not couple to
// itself
- std::vector<std::vector<bool> > mask (dim+1, std::vector<bool> (dim+1, true));
- mask[dim][dim] = false;
+ Table<2,DoFTools::Coupling> mask (dim+1, dim+1);
+ for (unsigned int i=0; i<dim+1; ++i)
+ for (unsigned int j=0; j<dim+1; ++j)
+ mask(i,j) = DoFTools::always;
+ mask[dim][dim] = DoFTools::none;
DoFTools::make_sparsity_pattern (dof_handler, mask, sparsity);
sparsity.compress ();
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different blocks should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (dim*2,
- std::vector<bool>(dim*2, false));
+ Table<2,DoFTools::Coupling> mask (2*dim, 2*dim);
+ for (unsigned int i=0; i<2*dim; ++i)
+ for (unsigned int j=0; j<2*dim; ++j)
+ mask[i][j] = DoFTools::none;
for (unsigned int i=0; i<dim; ++i)
for (unsigned int j=0; j<dim; ++j)
- mask[i][j] = true;
+ mask[i][j] = DoFTools::always;
for (unsigned int i=0; i<dim; ++i)
for (unsigned int j=0; j<dim; ++j)
- mask[dim+i][dim+j] = true;
+ mask[dim+i][dim+j] = DoFTools::always;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);
// ---------------------------------------------------------------------
//
-// Copyright (C) 2000 - 2013 by the deal.II authors
+// Copyright (C) 2000 - 2013, 2015 by the deal.II authors
//
// This file is part of the deal.II library.
//
// that different components should
// not couple, so use pattern
SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs());
- std::vector<std::vector<bool> > mask (2, std::vector<bool>(2, false));
- mask[0][0] = mask[1][1] = true;
+ Table<2,DoFTools::Coupling> mask (2, 2);
+ mask(0,0) = mask(1,1) = DoFTools::always;
+ mask(0,1) = mask(1,0) = DoFTools::none;
DoFTools::make_sparsity_pattern (dof, mask, sparsity);
ConstraintMatrix constraints;
DoFTools::make_hanging_node_constraints (dof, constraints);