#include <deal.II/fe/fe_tools.h>
#include <deal.II/grid/grid_generator.h>
#include <deal.II/lac/sparsity_tools.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/petsc_parallel_vector.h>
#include <deal.II/lac/petsc_parallel_sparse_matrix.h>
constraints);
constraints.close ();
- dealii::CompressedSimpleSparsityPattern csp (locally_relevant_dofs);
+ dealii::DynamicSparsityPattern csp (locally_relevant_dofs);
// Fill in ignoring all cells that are not locally owned
dealii::DoFTools::make_sparsity_pattern (dof_handler, csp,
constraints,
#include <deal.II/fe/fe_tools.h>
#include <deal.II/grid/grid_generator.h>
#include <deal.II/lac/sparsity_tools.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/iterative_inverse.h>
constraints);
constraints.close ();
- CompressedSimpleSparsityPattern csp (locally_relevant_dofs);
+ DynamicSparsityPattern csp (locally_relevant_dofs);
// Fill in ignoring all cells that are not locally owned
DoFTools::make_sparsity_pattern (dof_handler, csp,
constraints,
#include <deal.II/fe/fe_tools.h>
#include <deal.II/grid/grid_generator.h>
#include <deal.II/lac/sparsity_tools.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/petsc_parallel_vector.h>
#include <deal.II/lac/petsc_parallel_sparse_matrix.h>
constraints);
constraints.close ();
- dealii::CompressedSimpleSparsityPattern csp (locally_relevant_dofs);
+ dealii::DynamicSparsityPattern csp (locally_relevant_dofs);
// Fill in ignoring all cells that are not locally owned
dealii::DoFTools::make_sparsity_pattern (dof_handler, csp,
constraints,
#include <deal.II/fe/fe_tools.h>
#include <deal.II/grid/grid_generator.h>
#include <deal.II/lac/sparsity_tools.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/iterative_inverse.h>
constraints);
constraints.close ();
- CompressedSimpleSparsityPattern csp (locally_relevant_dofs);
+ DynamicSparsityPattern csp (locally_relevant_dofs);
// Fill in ignoring all cells that are not locally owned
DoFTools::make_sparsity_pattern (dof_handler, csp,
constraints,
#include <deal.II/lac/vector.h>
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/precondition.h>
#include <deal.II/grid/tria.h>
hanging_node_constraints.close ();
- CompressedSparsityPattern c_sparsity(dof_handler.n_dofs());
+ DynamicSparsityPattern c_sparsity(dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, c_sparsity);
hanging_node_constraints.condense (c_sparsity);
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSetSparsityPattern::n_nonzero_elements. test n_rows() and
-// n_cols() in passing
-
-#include "../tests.h"
-#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
-#include <iomanip>
-#include <fstream>
-
-
-void test ()
-{
- // set up a sparsity pattern. since
- // CompressedSetSparsityPatterns are most
- // often used for 3d, use a rather large
- // number of entries per row
- const unsigned int N = 1000;
- CompressedSetSparsityPattern csp (N,N);
- for (unsigned int i=0; i<N; ++i)
- for (unsigned int j=0; j<40; ++j)
- csp.add (i, (i+(i+1)*(j*j+i))%N);
-
- Assert (csp.n_rows() == N, ExcInternalError());
- Assert (csp.n_cols() == N, ExcInternalError());
- deallog << csp.n_nonzero_elements () << std::endl;
-}
-
-
-
-int main ()
-{
- std::ofstream logfile("output");
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- test ();
- return 0;
-}
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSetSparsityPattern::bandwidth
-
-#include "../tests.h"
-#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
-#include <iomanip>
-#include <fstream>
-
-
-void test ()
-{
- // set up a sparsity pattern. since
- // CompressedSetSparsityPatterns are most
- // often used for 3d, use a rather large
- // number of entries per row
- const unsigned int N = 1000;
- CompressedSetSparsityPattern csp (N,N);
- for (unsigned int i=0; i<N; ++i)
- for (unsigned int j=0; j<40; ++j)
- csp.add (i, (i+(i+1)*(j*j+i))%N);
-
- deallog << csp.bandwidth () << std::endl;
-}
-
-
-
-int main ()
-{
- std::ofstream logfile("output");
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- test ();
- return 0;
-}
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSetSparsityPattern::row_length
-
-#include "../tests.h"
-#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
-#include <iomanip>
-#include <fstream>
-
-
-void test ()
-{
- // set up a sparsity pattern. since
- // CompressedSetSparsityPatterns are most
- // often used for 3d, use a rather large
- // number of entries per row
- const unsigned int N = 1000;
- CompressedSetSparsityPattern csp (N,N);
- for (unsigned int i=0; i<N; ++i)
- for (unsigned int j=0; j<40; ++j)
- csp.add (i, (i+(i+1)*(j*j+i))%N);
-
- for (unsigned int i=0; i<N; ++i)
- {
- std::vector<bool> xx(1000, false);
- for (unsigned int j=0; j<40; ++j)
- xx[(i+(i+1)*(j*j+i))%N] = true;
-
- Assert (static_cast<unsigned int>(std::count (xx.begin(), xx.end(),
- true))
- == csp.row_length(i),
- ExcInternalError());
-
- deallog << i << ' ' << csp.row_length (i) << std::endl;
- }
-}
-
-
-
-int main ()
-{
- std::ofstream logfile("output");
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- test ();
- return 0;
-}
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSetSparsityPattern::begin iterators. since we create
-// quite some output here, choose smaller number of rows and entries than in
-// the other tests
-
-#include "../tests.h"
-#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
-#include <iomanip>
-#include <fstream>
-
-
-void test ()
-{
- const unsigned int N = 100;
- CompressedSetSparsityPattern csp (N,N);
- for (unsigned int i=0; i<N; ++i)
- for (unsigned int j=0; j<10; ++j)
- csp.add (i, (i+(i+1)*(j*j+i))%N);
-
- for (unsigned int i=0; i<N; ++i)
- {
- unsigned int index = 0;
- for (CompressedSetSparsityPattern::iterator
- j = csp.begin(i); j != csp.end(i); ++j, ++index)
- deallog << i << ' ' << index << ' ' << j->column()
- << std::endl;
- }
-}
-
-
-
-int main ()
-{
- std::ofstream logfile("output");
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- test ();
- return 0;
-}
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSetSparsityPattern::symmetrize. since we create quite some
-// output here, choose smaller number of rows and entries than in the other
-// tests
-
-#include "../tests.h"
-#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
-#include <iomanip>
-#include <fstream>
-
-
-void test ()
-{
- const unsigned int N = 100;
- CompressedSetSparsityPattern csp (N,N);
- for (unsigned int i=0; i<N; ++i)
- for (unsigned int j=0; j<10; ++j)
- csp.add (i, (i+(i+1)*(j*j+i))%N);
- csp.symmetrize ();
-
- for (unsigned int i=0; i<N; ++i)
- {
- unsigned int index = 0;
- for (CompressedSetSparsityPattern::iterator
- j = csp.begin(i); j != csp.end(i); ++j, ++index)
- deallog << i << ' ' << index << ' ' << j->column()
- << std::endl;
- }
-}
-
-
-
-int main ()
-{
- std::ofstream logfile("output");
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- test ();
- return 0;
-}
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSetSparsityPattern::print_gnuplot. since we create quite some
-// output here, choose smaller number of rows and entries than in the other
-// tests
-
-#include "../tests.h"
-#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
-#include <iomanip>
-#include <fstream>
-
-
-std::ofstream logfile("output");
-
-void test ()
-{
- const unsigned int N = 100;
- CompressedSetSparsityPattern csp (N,N);
- for (unsigned int i=0; i<N; ++i)
- for (unsigned int j=0; j<10; ++j)
- csp.add (i, (i+(i+1)*(j*j+i))%N);
- csp.symmetrize ();
-
- csp.print_gnuplot (logfile);
- deallog << "OK" << std::endl;
-}
-
-
-
-int main ()
-{
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- test ();
- return 0;
-}
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSetSparsityPattern::exists. since we create quite some
-// output here, choose smaller number of rows and entries than in the other
-// tests
-
-#include "../tests.h"
-#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
-#include <iomanip>
-#include <fstream>
-
-
-void test ()
-{
- const unsigned int N = 100;
- CompressedSetSparsityPattern csp (N,N);
- for (unsigned int i=0; i<N; ++i)
- for (unsigned int j=0; j<10; ++j)
- csp.add (i, (i+(i+1)*(j*j+i))%N);
- csp.symmetrize ();
-
- for (unsigned int i=0; i<N; ++i)
- {
- deallog << i << ' ';
- for (unsigned int j=0; j<N; ++j)
- deallog << (csp.exists(i,j) ? 'x' : ' ');
- deallog << std::endl;
- }
-}
-
-
-
-int main ()
-{
- std::ofstream logfile("output");
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- test ();
- return 0;
-}
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSetSparsityPattern::max_entries_per_row
-
-#include "../tests.h"
-#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
-#include <iomanip>
-#include <fstream>
-
-
-void test ()
-{
- // set up a sparsity pattern. since
- // CompressedSetSparsityPatterns are most
- // often used for 3d, use a rather large
- // number of entries per row
- const unsigned int N = 1000;
- CompressedSetSparsityPattern csp (N,N);
- for (unsigned int i=0; i<N; ++i)
- for (unsigned int j=0; j<40; ++j)
- csp.add (i, (i+(i+1)*(j*j+i))%N);
-
- deallog << ' ' << csp.max_entries_per_row () << std::endl;
-}
-
-
-
-int main ()
-{
- std::ofstream logfile("output");
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- test ();
- return 0;
-}
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2004 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSetSparsityPattern::empty
-
-#include "../tests.h"
-#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
-#include <iomanip>
-#include <fstream>
-
-
-void test ()
-{
- const unsigned int N = 1000;
- CompressedSetSparsityPattern csp;
- AssertThrow (csp.empty() == true, ExcInternalError());
-
- csp.reinit (N, N);
- AssertThrow (csp.empty() == false, ExcInternalError());
-
- deallog << "OK" << std::endl;
-}
-
-
-
-int main ()
-{
- std::ofstream logfile("output");
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- test ();
- return 0;
-}
+++ /dev/null
-
-DEAL::34607
+++ /dev/null
-
-DEAL::998
+++ /dev/null
-
-DEAL::0 39
-DEAL::1 38
-DEAL::2 39
-DEAL::3 38
-DEAL::4 29
-DEAL::5 38
-DEAL::6 39
-DEAL::7 35
-DEAL::8 39
-DEAL::9 22
-DEAL::10 39
-DEAL::11 38
-DEAL::12 39
-DEAL::13 38
-DEAL::14 29
-DEAL::15 35
-DEAL::16 39
-DEAL::17 38
-DEAL::18 39
-DEAL::19 22
-DEAL::20 39
-DEAL::21 38
-DEAL::22 39
-DEAL::23 35
-DEAL::24 9
-DEAL::25 38
-DEAL::26 39
-DEAL::27 38
-DEAL::28 39
-DEAL::29 22
-DEAL::30 39
-DEAL::31 35
-DEAL::32 39
-DEAL::33 38
-DEAL::34 29
-DEAL::35 38
-DEAL::36 39
-DEAL::37 38
-DEAL::38 39
-DEAL::39 11
-DEAL::40 39
-DEAL::41 38
-DEAL::42 39
-DEAL::43 38
-DEAL::44 29
-DEAL::45 38
-DEAL::46 39
-DEAL::47 35
-DEAL::48 39
-DEAL::49 6
-DEAL::50 39
-DEAL::51 38
-DEAL::52 39
-DEAL::53 38
-DEAL::54 29
-DEAL::55 35
-DEAL::56 39
-DEAL::57 38
-DEAL::58 39
-DEAL::59 22
-DEAL::60 39
-DEAL::61 38
-DEAL::62 39
-DEAL::63 35
-DEAL::64 29
-DEAL::65 38
-DEAL::66 39
-DEAL::67 38
-DEAL::68 39
-DEAL::69 22
-DEAL::70 39
-DEAL::71 35
-DEAL::72 39
-DEAL::73 38
-DEAL::74 9
-DEAL::75 38
-DEAL::76 39
-DEAL::77 38
-DEAL::78 39
-DEAL::79 11
-DEAL::80 39
-DEAL::81 38
-DEAL::82 39
-DEAL::83 38
-DEAL::84 29
-DEAL::85 38
-DEAL::86 39
-DEAL::87 35
-DEAL::88 39
-DEAL::89 22
-DEAL::90 39
-DEAL::91 38
-DEAL::92 39
-DEAL::93 38
-DEAL::94 29
-DEAL::95 35
-DEAL::96 39
-DEAL::97 38
-DEAL::98 39
-DEAL::99 6
-DEAL::100 39
-DEAL::101 38
-DEAL::102 39
-DEAL::103 35
-DEAL::104 29
-DEAL::105 38
-DEAL::106 39
-DEAL::107 38
-DEAL::108 39
-DEAL::109 22
-DEAL::110 39
-DEAL::111 35
-DEAL::112 39
-DEAL::113 38
-DEAL::114 29
-DEAL::115 38
-DEAL::116 39
-DEAL::117 38
-DEAL::118 39
-DEAL::119 11
-DEAL::120 39
-DEAL::121 38
-DEAL::122 39
-DEAL::123 38
-DEAL::124 3
-DEAL::125 38
-DEAL::126 39
-DEAL::127 35
-DEAL::128 39
-DEAL::129 22
-DEAL::130 39
-DEAL::131 38
-DEAL::132 39
-DEAL::133 38
-DEAL::134 29
-DEAL::135 35
-DEAL::136 39
-DEAL::137 38
-DEAL::138 39
-DEAL::139 22
-DEAL::140 39
-DEAL::141 38
-DEAL::142 39
-DEAL::143 35
-DEAL::144 29
-DEAL::145 38
-DEAL::146 39
-DEAL::147 38
-DEAL::148 39
-DEAL::149 6
-DEAL::150 39
-DEAL::151 35
-DEAL::152 39
-DEAL::153 38
-DEAL::154 29
-DEAL::155 38
-DEAL::156 39
-DEAL::157 38
-DEAL::158 39
-DEAL::159 11
-DEAL::160 39
-DEAL::161 38
-DEAL::162 39
-DEAL::163 38
-DEAL::164 29
-DEAL::165 38
-DEAL::166 39
-DEAL::167 35
-DEAL::168 39
-DEAL::169 22
-DEAL::170 39
-DEAL::171 38
-DEAL::172 39
-DEAL::173 38
-DEAL::174 9
-DEAL::175 35
-DEAL::176 39
-DEAL::177 38
-DEAL::178 39
-DEAL::179 22
-DEAL::180 39
-DEAL::181 38
-DEAL::182 39
-DEAL::183 35
-DEAL::184 29
-DEAL::185 38
-DEAL::186 39
-DEAL::187 38
-DEAL::188 39
-DEAL::189 22
-DEAL::190 39
-DEAL::191 35
-DEAL::192 39
-DEAL::193 38
-DEAL::194 29
-DEAL::195 38
-DEAL::196 39
-DEAL::197 38
-DEAL::198 39
-DEAL::199 3
-DEAL::200 39
-DEAL::201 38
-DEAL::202 39
-DEAL::203 38
-DEAL::204 29
-DEAL::205 38
-DEAL::206 39
-DEAL::207 35
-DEAL::208 39
-DEAL::209 22
-DEAL::210 39
-DEAL::211 38
-DEAL::212 39
-DEAL::213 38
-DEAL::214 29
-DEAL::215 35
-DEAL::216 39
-DEAL::217 38
-DEAL::218 39
-DEAL::219 22
-DEAL::220 39
-DEAL::221 38
-DEAL::222 39
-DEAL::223 35
-DEAL::224 9
-DEAL::225 38
-DEAL::226 39
-DEAL::227 38
-DEAL::228 39
-DEAL::229 22
-DEAL::230 39
-DEAL::231 35
-DEAL::232 39
-DEAL::233 38
-DEAL::234 29
-DEAL::235 38
-DEAL::236 39
-DEAL::237 38
-DEAL::238 39
-DEAL::239 11
-DEAL::240 39
-DEAL::241 38
-DEAL::242 39
-DEAL::243 38
-DEAL::244 29
-DEAL::245 38
-DEAL::246 39
-DEAL::247 35
-DEAL::248 39
-DEAL::249 2
-DEAL::250 39
-DEAL::251 38
-DEAL::252 39
-DEAL::253 38
-DEAL::254 29
-DEAL::255 35
-DEAL::256 39
-DEAL::257 38
-DEAL::258 39
-DEAL::259 22
-DEAL::260 39
-DEAL::261 38
-DEAL::262 39
-DEAL::263 35
-DEAL::264 29
-DEAL::265 38
-DEAL::266 39
-DEAL::267 38
-DEAL::268 39
-DEAL::269 22
-DEAL::270 39
-DEAL::271 35
-DEAL::272 39
-DEAL::273 38
-DEAL::274 9
-DEAL::275 38
-DEAL::276 39
-DEAL::277 38
-DEAL::278 39
-DEAL::279 11
-DEAL::280 39
-DEAL::281 38
-DEAL::282 39
-DEAL::283 38
-DEAL::284 29
-DEAL::285 38
-DEAL::286 39
-DEAL::287 35
-DEAL::288 39
-DEAL::289 22
-DEAL::290 39
-DEAL::291 38
-DEAL::292 39
-DEAL::293 38
-DEAL::294 29
-DEAL::295 35
-DEAL::296 39
-DEAL::297 38
-DEAL::298 39
-DEAL::299 6
-DEAL::300 39
-DEAL::301 38
-DEAL::302 39
-DEAL::303 35
-DEAL::304 29
-DEAL::305 38
-DEAL::306 39
-DEAL::307 38
-DEAL::308 39
-DEAL::309 22
-DEAL::310 39
-DEAL::311 35
-DEAL::312 39
-DEAL::313 38
-DEAL::314 29
-DEAL::315 38
-DEAL::316 39
-DEAL::317 38
-DEAL::318 39
-DEAL::319 11
-DEAL::320 39
-DEAL::321 38
-DEAL::322 39
-DEAL::323 38
-DEAL::324 9
-DEAL::325 38
-DEAL::326 39
-DEAL::327 35
-DEAL::328 39
-DEAL::329 22
-DEAL::330 39
-DEAL::331 38
-DEAL::332 39
-DEAL::333 38
-DEAL::334 29
-DEAL::335 35
-DEAL::336 39
-DEAL::337 38
-DEAL::338 39
-DEAL::339 22
-DEAL::340 39
-DEAL::341 38
-DEAL::342 39
-DEAL::343 35
-DEAL::344 29
-DEAL::345 38
-DEAL::346 39
-DEAL::347 38
-DEAL::348 39
-DEAL::349 6
-DEAL::350 39
-DEAL::351 35
-DEAL::352 39
-DEAL::353 38
-DEAL::354 29
-DEAL::355 38
-DEAL::356 39
-DEAL::357 38
-DEAL::358 39
-DEAL::359 11
-DEAL::360 39
-DEAL::361 38
-DEAL::362 39
-DEAL::363 38
-DEAL::364 29
-DEAL::365 38
-DEAL::366 39
-DEAL::367 35
-DEAL::368 39
-DEAL::369 22
-DEAL::370 39
-DEAL::371 38
-DEAL::372 39
-DEAL::373 38
-DEAL::374 3
-DEAL::375 35
-DEAL::376 39
-DEAL::377 38
-DEAL::378 39
-DEAL::379 22
-DEAL::380 39
-DEAL::381 38
-DEAL::382 39
-DEAL::383 35
-DEAL::384 29
-DEAL::385 38
-DEAL::386 39
-DEAL::387 38
-DEAL::388 39
-DEAL::389 22
-DEAL::390 39
-DEAL::391 35
-DEAL::392 39
-DEAL::393 38
-DEAL::394 29
-DEAL::395 38
-DEAL::396 39
-DEAL::397 38
-DEAL::398 39
-DEAL::399 3
-DEAL::400 39
-DEAL::401 38
-DEAL::402 39
-DEAL::403 38
-DEAL::404 29
-DEAL::405 38
-DEAL::406 39
-DEAL::407 35
-DEAL::408 39
-DEAL::409 22
-DEAL::410 39
-DEAL::411 38
-DEAL::412 39
-DEAL::413 38
-DEAL::414 29
-DEAL::415 35
-DEAL::416 39
-DEAL::417 38
-DEAL::418 39
-DEAL::419 22
-DEAL::420 39
-DEAL::421 38
-DEAL::422 39
-DEAL::423 35
-DEAL::424 9
-DEAL::425 38
-DEAL::426 39
-DEAL::427 38
-DEAL::428 39
-DEAL::429 22
-DEAL::430 39
-DEAL::431 35
-DEAL::432 39
-DEAL::433 38
-DEAL::434 29
-DEAL::435 38
-DEAL::436 39
-DEAL::437 38
-DEAL::438 39
-DEAL::439 11
-DEAL::440 39
-DEAL::441 38
-DEAL::442 39
-DEAL::443 38
-DEAL::444 29
-DEAL::445 38
-DEAL::446 39
-DEAL::447 35
-DEAL::448 39
-DEAL::449 6
-DEAL::450 39
-DEAL::451 38
-DEAL::452 39
-DEAL::453 38
-DEAL::454 29
-DEAL::455 35
-DEAL::456 39
-DEAL::457 38
-DEAL::458 39
-DEAL::459 22
-DEAL::460 39
-DEAL::461 38
-DEAL::462 39
-DEAL::463 35
-DEAL::464 29
-DEAL::465 38
-DEAL::466 39
-DEAL::467 38
-DEAL::468 39
-DEAL::469 22
-DEAL::470 39
-DEAL::471 35
-DEAL::472 39
-DEAL::473 38
-DEAL::474 9
-DEAL::475 38
-DEAL::476 39
-DEAL::477 38
-DEAL::478 39
-DEAL::479 11
-DEAL::480 39
-DEAL::481 38
-DEAL::482 39
-DEAL::483 38
-DEAL::484 29
-DEAL::485 38
-DEAL::486 39
-DEAL::487 35
-DEAL::488 39
-DEAL::489 22
-DEAL::490 39
-DEAL::491 38
-DEAL::492 39
-DEAL::493 38
-DEAL::494 29
-DEAL::495 35
-DEAL::496 39
-DEAL::497 38
-DEAL::498 39
-DEAL::499 2
-DEAL::500 39
-DEAL::501 38
-DEAL::502 39
-DEAL::503 35
-DEAL::504 29
-DEAL::505 38
-DEAL::506 39
-DEAL::507 38
-DEAL::508 39
-DEAL::509 22
-DEAL::510 39
-DEAL::511 35
-DEAL::512 39
-DEAL::513 38
-DEAL::514 29
-DEAL::515 38
-DEAL::516 39
-DEAL::517 38
-DEAL::518 39
-DEAL::519 11
-DEAL::520 39
-DEAL::521 38
-DEAL::522 39
-DEAL::523 38
-DEAL::524 9
-DEAL::525 38
-DEAL::526 39
-DEAL::527 35
-DEAL::528 39
-DEAL::529 22
-DEAL::530 39
-DEAL::531 38
-DEAL::532 39
-DEAL::533 38
-DEAL::534 29
-DEAL::535 35
-DEAL::536 39
-DEAL::537 38
-DEAL::538 39
-DEAL::539 22
-DEAL::540 39
-DEAL::541 38
-DEAL::542 39
-DEAL::543 35
-DEAL::544 29
-DEAL::545 38
-DEAL::546 39
-DEAL::547 38
-DEAL::548 39
-DEAL::549 6
-DEAL::550 39
-DEAL::551 35
-DEAL::552 39
-DEAL::553 38
-DEAL::554 29
-DEAL::555 38
-DEAL::556 39
-DEAL::557 38
-DEAL::558 39
-DEAL::559 11
-DEAL::560 39
-DEAL::561 38
-DEAL::562 39
-DEAL::563 38
-DEAL::564 29
-DEAL::565 38
-DEAL::566 39
-DEAL::567 35
-DEAL::568 39
-DEAL::569 22
-DEAL::570 39
-DEAL::571 38
-DEAL::572 39
-DEAL::573 38
-DEAL::574 9
-DEAL::575 35
-DEAL::576 39
-DEAL::577 38
-DEAL::578 39
-DEAL::579 22
-DEAL::580 39
-DEAL::581 38
-DEAL::582 39
-DEAL::583 35
-DEAL::584 29
-DEAL::585 38
-DEAL::586 39
-DEAL::587 38
-DEAL::588 39
-DEAL::589 22
-DEAL::590 39
-DEAL::591 35
-DEAL::592 39
-DEAL::593 38
-DEAL::594 29
-DEAL::595 38
-DEAL::596 39
-DEAL::597 38
-DEAL::598 39
-DEAL::599 3
-DEAL::600 39
-DEAL::601 38
-DEAL::602 39
-DEAL::603 38
-DEAL::604 29
-DEAL::605 38
-DEAL::606 39
-DEAL::607 35
-DEAL::608 39
-DEAL::609 22
-DEAL::610 39
-DEAL::611 38
-DEAL::612 39
-DEAL::613 38
-DEAL::614 29
-DEAL::615 35
-DEAL::616 39
-DEAL::617 38
-DEAL::618 39
-DEAL::619 22
-DEAL::620 39
-DEAL::621 38
-DEAL::622 39
-DEAL::623 35
-DEAL::624 3
-DEAL::625 38
-DEAL::626 39
-DEAL::627 38
-DEAL::628 39
-DEAL::629 22
-DEAL::630 39
-DEAL::631 35
-DEAL::632 39
-DEAL::633 38
-DEAL::634 29
-DEAL::635 38
-DEAL::636 39
-DEAL::637 38
-DEAL::638 39
-DEAL::639 11
-DEAL::640 39
-DEAL::641 38
-DEAL::642 39
-DEAL::643 38
-DEAL::644 29
-DEAL::645 38
-DEAL::646 39
-DEAL::647 35
-DEAL::648 39
-DEAL::649 6
-DEAL::650 39
-DEAL::651 38
-DEAL::652 39
-DEAL::653 38
-DEAL::654 29
-DEAL::655 35
-DEAL::656 39
-DEAL::657 38
-DEAL::658 39
-DEAL::659 22
-DEAL::660 39
-DEAL::661 38
-DEAL::662 39
-DEAL::663 35
-DEAL::664 29
-DEAL::665 38
-DEAL::666 39
-DEAL::667 38
-DEAL::668 39
-DEAL::669 22
-DEAL::670 39
-DEAL::671 35
-DEAL::672 39
-DEAL::673 38
-DEAL::674 9
-DEAL::675 38
-DEAL::676 39
-DEAL::677 38
-DEAL::678 39
-DEAL::679 11
-DEAL::680 39
-DEAL::681 38
-DEAL::682 39
-DEAL::683 38
-DEAL::684 29
-DEAL::685 38
-DEAL::686 39
-DEAL::687 35
-DEAL::688 39
-DEAL::689 22
-DEAL::690 39
-DEAL::691 38
-DEAL::692 39
-DEAL::693 38
-DEAL::694 29
-DEAL::695 35
-DEAL::696 39
-DEAL::697 38
-DEAL::698 39
-DEAL::699 6
-DEAL::700 39
-DEAL::701 38
-DEAL::702 39
-DEAL::703 35
-DEAL::704 29
-DEAL::705 38
-DEAL::706 39
-DEAL::707 38
-DEAL::708 39
-DEAL::709 22
-DEAL::710 39
-DEAL::711 35
-DEAL::712 39
-DEAL::713 38
-DEAL::714 29
-DEAL::715 38
-DEAL::716 39
-DEAL::717 38
-DEAL::718 39
-DEAL::719 11
-DEAL::720 39
-DEAL::721 38
-DEAL::722 39
-DEAL::723 38
-DEAL::724 9
-DEAL::725 38
-DEAL::726 39
-DEAL::727 35
-DEAL::728 39
-DEAL::729 22
-DEAL::730 39
-DEAL::731 38
-DEAL::732 39
-DEAL::733 38
-DEAL::734 29
-DEAL::735 35
-DEAL::736 39
-DEAL::737 38
-DEAL::738 39
-DEAL::739 22
-DEAL::740 39
-DEAL::741 38
-DEAL::742 39
-DEAL::743 35
-DEAL::744 29
-DEAL::745 38
-DEAL::746 39
-DEAL::747 38
-DEAL::748 39
-DEAL::749 2
-DEAL::750 39
-DEAL::751 35
-DEAL::752 39
-DEAL::753 38
-DEAL::754 29
-DEAL::755 38
-DEAL::756 39
-DEAL::757 38
-DEAL::758 39
-DEAL::759 11
-DEAL::760 39
-DEAL::761 38
-DEAL::762 39
-DEAL::763 38
-DEAL::764 29
-DEAL::765 38
-DEAL::766 39
-DEAL::767 35
-DEAL::768 39
-DEAL::769 22
-DEAL::770 39
-DEAL::771 38
-DEAL::772 39
-DEAL::773 38
-DEAL::774 9
-DEAL::775 35
-DEAL::776 39
-DEAL::777 38
-DEAL::778 39
-DEAL::779 22
-DEAL::780 39
-DEAL::781 38
-DEAL::782 39
-DEAL::783 35
-DEAL::784 29
-DEAL::785 38
-DEAL::786 39
-DEAL::787 38
-DEAL::788 39
-DEAL::789 22
-DEAL::790 39
-DEAL::791 35
-DEAL::792 39
-DEAL::793 38
-DEAL::794 29
-DEAL::795 38
-DEAL::796 39
-DEAL::797 38
-DEAL::798 39
-DEAL::799 3
-DEAL::800 39
-DEAL::801 38
-DEAL::802 39
-DEAL::803 38
-DEAL::804 29
-DEAL::805 38
-DEAL::806 39
-DEAL::807 35
-DEAL::808 39
-DEAL::809 22
-DEAL::810 39
-DEAL::811 38
-DEAL::812 39
-DEAL::813 38
-DEAL::814 29
-DEAL::815 35
-DEAL::816 39
-DEAL::817 38
-DEAL::818 39
-DEAL::819 22
-DEAL::820 39
-DEAL::821 38
-DEAL::822 39
-DEAL::823 35
-DEAL::824 9
-DEAL::825 38
-DEAL::826 39
-DEAL::827 38
-DEAL::828 39
-DEAL::829 22
-DEAL::830 39
-DEAL::831 35
-DEAL::832 39
-DEAL::833 38
-DEAL::834 29
-DEAL::835 38
-DEAL::836 39
-DEAL::837 38
-DEAL::838 39
-DEAL::839 11
-DEAL::840 39
-DEAL::841 38
-DEAL::842 39
-DEAL::843 38
-DEAL::844 29
-DEAL::845 38
-DEAL::846 39
-DEAL::847 35
-DEAL::848 39
-DEAL::849 6
-DEAL::850 39
-DEAL::851 38
-DEAL::852 39
-DEAL::853 38
-DEAL::854 29
-DEAL::855 35
-DEAL::856 39
-DEAL::857 38
-DEAL::858 39
-DEAL::859 22
-DEAL::860 39
-DEAL::861 38
-DEAL::862 39
-DEAL::863 35
-DEAL::864 29
-DEAL::865 38
-DEAL::866 39
-DEAL::867 38
-DEAL::868 39
-DEAL::869 22
-DEAL::870 39
-DEAL::871 35
-DEAL::872 39
-DEAL::873 38
-DEAL::874 3
-DEAL::875 38
-DEAL::876 39
-DEAL::877 38
-DEAL::878 39
-DEAL::879 11
-DEAL::880 39
-DEAL::881 38
-DEAL::882 39
-DEAL::883 38
-DEAL::884 29
-DEAL::885 38
-DEAL::886 39
-DEAL::887 35
-DEAL::888 39
-DEAL::889 22
-DEAL::890 39
-DEAL::891 38
-DEAL::892 39
-DEAL::893 38
-DEAL::894 29
-DEAL::895 35
-DEAL::896 39
-DEAL::897 38
-DEAL::898 39
-DEAL::899 6
-DEAL::900 39
-DEAL::901 38
-DEAL::902 39
-DEAL::903 35
-DEAL::904 29
-DEAL::905 38
-DEAL::906 39
-DEAL::907 38
-DEAL::908 39
-DEAL::909 22
-DEAL::910 39
-DEAL::911 35
-DEAL::912 39
-DEAL::913 38
-DEAL::914 29
-DEAL::915 38
-DEAL::916 39
-DEAL::917 38
-DEAL::918 39
-DEAL::919 11
-DEAL::920 39
-DEAL::921 38
-DEAL::922 39
-DEAL::923 38
-DEAL::924 9
-DEAL::925 38
-DEAL::926 39
-DEAL::927 35
-DEAL::928 39
-DEAL::929 22
-DEAL::930 39
-DEAL::931 38
-DEAL::932 39
-DEAL::933 38
-DEAL::934 29
-DEAL::935 35
-DEAL::936 39
-DEAL::937 38
-DEAL::938 39
-DEAL::939 22
-DEAL::940 39
-DEAL::941 38
-DEAL::942 39
-DEAL::943 35
-DEAL::944 29
-DEAL::945 38
-DEAL::946 39
-DEAL::947 38
-DEAL::948 39
-DEAL::949 6
-DEAL::950 39
-DEAL::951 35
-DEAL::952 39
-DEAL::953 38
-DEAL::954 29
-DEAL::955 38
-DEAL::956 39
-DEAL::957 38
-DEAL::958 39
-DEAL::959 11
-DEAL::960 39
-DEAL::961 38
-DEAL::962 39
-DEAL::963 38
-DEAL::964 29
-DEAL::965 38
-DEAL::966 39
-DEAL::967 35
-DEAL::968 39
-DEAL::969 22
-DEAL::970 39
-DEAL::971 38
-DEAL::972 39
-DEAL::973 38
-DEAL::974 9
-DEAL::975 35
-DEAL::976 39
-DEAL::977 38
-DEAL::978 39
-DEAL::979 22
-DEAL::980 39
-DEAL::981 38
-DEAL::982 39
-DEAL::983 35
-DEAL::984 29
-DEAL::985 38
-DEAL::986 39
-DEAL::987 38
-DEAL::988 39
-DEAL::989 22
-DEAL::990 39
-DEAL::991 35
-DEAL::992 39
-DEAL::993 38
-DEAL::994 29
-DEAL::995 38
-DEAL::996 39
-DEAL::997 38
-DEAL::998 39
-DEAL::999 1
+++ /dev/null
-
-DEAL::0 0 0
-DEAL::0 1 1
-DEAL::0 2 4
-DEAL::0 3 9
-DEAL::0 4 16
-DEAL::0 5 25
-DEAL::0 6 36
-DEAL::0 7 49
-DEAL::0 8 64
-DEAL::0 9 81
-DEAL::1 0 1
-DEAL::1 1 3
-DEAL::1 2 5
-DEAL::1 3 11
-DEAL::1 4 21
-DEAL::1 5 31
-DEAL::1 6 35
-DEAL::1 7 53
-DEAL::1 8 65
-DEAL::1 9 75
-DEAL::2 0 0
-DEAL::2 1 8
-DEAL::2 2 11
-DEAL::2 3 16
-DEAL::2 4 20
-DEAL::2 5 35
-DEAL::2 6 51
-DEAL::2 7 55
-DEAL::2 8 56
-DEAL::2 9 83
-DEAL::3 0 11
-DEAL::3 1 15
-DEAL::3 2 19
-DEAL::3 3 31
-DEAL::3 4 39
-DEAL::3 5 51
-DEAL::3 6 59
-DEAL::3 7 71
-DEAL::3 8 79
-DEAL::4 0 4
-DEAL::4 1 24
-DEAL::4 2 29
-DEAL::4 3 44
-DEAL::4 4 49
-DEAL::4 5 69
-DEAL::5 0 19
-DEAL::5 1 21
-DEAL::5 2 29
-DEAL::5 3 31
-DEAL::5 4 35
-DEAL::5 5 41
-DEAL::5 6 51
-DEAL::5 7 59
-DEAL::5 8 85
-DEAL::5 9 89
-DEAL::6 0 0
-DEAL::6 1 11
-DEAL::6 2 15
-DEAL::6 3 23
-DEAL::6 4 48
-DEAL::6 5 55
-DEAL::6 6 60
-DEAL::6 7 76
-DEAL::6 8 91
-DEAL::6 9 96
-DEAL::7 0 11
-DEAL::7 1 35
-DEAL::7 2 51
-DEAL::7 3 55
-DEAL::7 4 63
-DEAL::7 5 71
-DEAL::7 6 75
-DEAL::7 7 91
-DEAL::7 8 95
-DEAL::8 0 4
-DEAL::8 1 5
-DEAL::8 2 9
-DEAL::8 3 16
-DEAL::8 4 21
-DEAL::8 5 24
-DEAL::8 6 56
-DEAL::8 7 61
-DEAL::8 8 80
-DEAL::8 9 89
-DEAL::9 0 9
-DEAL::9 1 39
-DEAL::9 2 49
-DEAL::9 3 59
-DEAL::9 4 89
-DEAL::9 5 99
-DEAL::10 0 11
-DEAL::10 1 16
-DEAL::10 2 19
-DEAL::10 3 20
-DEAL::10 4 24
-DEAL::10 5 31
-DEAL::10 6 59
-DEAL::10 7 64
-DEAL::10 8 95
-DEAL::10 9 96
-DEAL::11 0 11
-DEAL::11 1 15
-DEAL::11 2 31
-DEAL::11 3 35
-DEAL::11 4 43
-DEAL::11 5 51
-DEAL::11 6 55
-DEAL::11 7 75
-DEAL::11 8 91
-DEAL::12 0 0
-DEAL::12 1 5
-DEAL::12 2 20
-DEAL::12 3 21
-DEAL::12 4 36
-DEAL::12 5 68
-DEAL::12 6 76
-DEAL::12 7 81
-DEAL::12 8 85
-DEAL::12 9 93
-DEAL::13 0 9
-DEAL::13 1 19
-DEAL::13 2 21
-DEAL::13 3 29
-DEAL::13 4 45
-DEAL::13 5 51
-DEAL::13 6 81
-DEAL::13 7 91
-DEAL::13 8 95
-DEAL::13 9 99
-DEAL::14 0 24
-DEAL::14 1 39
-DEAL::14 2 59
-DEAL::14 3 64
-DEAL::14 4 84
-DEAL::14 5 99
-DEAL::15 0 11
-DEAL::15 1 19
-DEAL::15 2 31
-DEAL::15 3 39
-DEAL::15 4 51
-DEAL::15 5 55
-DEAL::15 6 71
-DEAL::15 7 79
-DEAL::15 8 99
-DEAL::16 0 0
-DEAL::16 1 5
-DEAL::16 2 13
-DEAL::16 3 21
-DEAL::16 4 41
-DEAL::16 5 56
-DEAL::16 6 60
-DEAL::16 7 65
-DEAL::16 8 76
-DEAL::16 9 88
-DEAL::17 0 5
-DEAL::17 1 11
-DEAL::17 2 23
-DEAL::17 3 41
-DEAL::17 4 71
-DEAL::17 5 73
-DEAL::17 6 75
-DEAL::17 7 81
-DEAL::17 8 85
-DEAL::17 9 95
-DEAL::18 0 31
-DEAL::18 1 35
-DEAL::18 2 36
-DEAL::18 3 44
-DEAL::18 4 60
-DEAL::18 5 64
-DEAL::18 6 76
-DEAL::18 7 79
-DEAL::18 8 91
-DEAL::18 9 99
-DEAL::19 0 19
-DEAL::19 1 79
-DEAL::19 2 99
-DEAL::20 0 24
-DEAL::20 1 29
-DEAL::20 2 40
-DEAL::20 3 41
-DEAL::20 4 61
-DEAL::20 5 65
-DEAL::20 6 69
-DEAL::20 7 76
-DEAL::20 8 84
-DEAL::20 9 96
-DEAL::21 0 5
-DEAL::21 1 33
-DEAL::21 2 35
-DEAL::21 3 61
-DEAL::21 4 65
-DEAL::21 5 71
-DEAL::21 6 75
-DEAL::21 7 81
-DEAL::21 8 83
-DEAL::21 9 91
-DEAL::22 0 0
-DEAL::22 1 3
-DEAL::22 2 20
-DEAL::22 3 28
-DEAL::22 4 35
-DEAL::22 5 51
-DEAL::22 6 55
-DEAL::22 7 56
-DEAL::22 8 91
-DEAL::22 9 96
-DEAL::23 0 11
-DEAL::23 1 19
-DEAL::23 2 39
-DEAL::23 3 51
-DEAL::23 4 59
-DEAL::23 5 71
-DEAL::23 6 75
-DEAL::23 7 91
-DEAL::23 8 99
-DEAL::24 0 24
-DEAL::24 1 49
-DEAL::25 0 1
-DEAL::25 1 9
-DEAL::25 2 11
-DEAL::25 3 25
-DEAL::25 4 39
-DEAL::25 5 49
-DEAL::25 6 75
-DEAL::25 7 79
-DEAL::25 8 81
-DEAL::25 9 91
-DEAL::26 0 0
-DEAL::26 1 3
-DEAL::26 2 15
-DEAL::26 3 28
-DEAL::26 4 36
-DEAL::26 5 51
-DEAL::26 6 55
-DEAL::26 7 56
-DEAL::26 8 60
-DEAL::26 9 71
-DEAL::27 0 11
-DEAL::27 1 31
-DEAL::27 2 35
-DEAL::27 3 51
-DEAL::27 4 55
-DEAL::27 5 75
-DEAL::27 6 83
-DEAL::27 7 91
-DEAL::27 8 95
-DEAL::28 0 1
-DEAL::28 1 4
-DEAL::28 2 40
-DEAL::28 3 56
-DEAL::28 4 61
-DEAL::28 5 65
-DEAL::28 6 69
-DEAL::28 7 84
-DEAL::28 8 89
-DEAL::28 9 96
-DEAL::29 0 19
-DEAL::29 1 29
-DEAL::29 2 49
-DEAL::29 3 69
-DEAL::29 4 79
-DEAL::29 5 99
-DEAL::30 0 35
-DEAL::30 1 39
-DEAL::30 2 44
-DEAL::30 3 56
-DEAL::30 4 60
-DEAL::30 5 71
-DEAL::30 6 76
-DEAL::30 7 79
-DEAL::30 8 84
-DEAL::30 9 91
-DEAL::31 0 11
-DEAL::31 1 15
-DEAL::31 2 23
-DEAL::31 3 35
-DEAL::31 4 51
-DEAL::31 5 55
-DEAL::31 6 71
-DEAL::31 7 75
-DEAL::31 8 91
-DEAL::32 0 0
-DEAL::32 1 5
-DEAL::32 2 13
-DEAL::32 3 16
-DEAL::32 4 20
-DEAL::32 5 21
-DEAL::32 6 61
-DEAL::32 7 76
-DEAL::32 8 85
-DEAL::32 9 88
-DEAL::33 0 5
-DEAL::33 1 9
-DEAL::33 2 21
-DEAL::33 3 31
-DEAL::33 4 55
-DEAL::33 5 61
-DEAL::33 6 79
-DEAL::33 7 89
-DEAL::33 8 91
-DEAL::33 9 99
-DEAL::34 0 24
-DEAL::34 1 39
-DEAL::34 2 59
-DEAL::34 3 64
-DEAL::34 4 84
-DEAL::34 5 99
-DEAL::35 0 11
-DEAL::35 1 19
-DEAL::35 2 31
-DEAL::35 3 39
-DEAL::35 4 59
-DEAL::35 5 71
-DEAL::35 6 91
-DEAL::35 7 95
-DEAL::35 8 99
-DEAL::36 0 0
-DEAL::36 1 1
-DEAL::36 2 5
-DEAL::36 3 16
-DEAL::36 4 36
-DEAL::36 5 60
-DEAL::36 6 65
-DEAL::36 7 68
-DEAL::36 8 81
-DEAL::36 9 93
-DEAL::37 0 5
-DEAL::37 1 11
-DEAL::37 2 21
-DEAL::37 3 43
-DEAL::37 4 51
-DEAL::37 5 75
-DEAL::37 6 81
-DEAL::37 7 85
-DEAL::37 8 93
-DEAL::37 9 95
-DEAL::38 0 16
-DEAL::38 1 20
-DEAL::38 2 24
-DEAL::38 3 31
-DEAL::38 4 44
-DEAL::38 5 59
-DEAL::38 6 71
-DEAL::38 7 76
-DEAL::38 8 79
-DEAL::38 9 95
-DEAL::39 0 39
-DEAL::39 1 59
-DEAL::39 2 99
-DEAL::40 0 1
-DEAL::40 1 4
-DEAL::40 2 5
-DEAL::40 3 21
-DEAL::40 4 36
-DEAL::40 5 44
-DEAL::40 6 49
-DEAL::40 7 56
-DEAL::40 8 80
-DEAL::40 9 89
-DEAL::41 0 5
-DEAL::41 1 13
-DEAL::41 2 21
-DEAL::41 3 31
-DEAL::41 4 35
-DEAL::41 5 41
-DEAL::41 6 51
-DEAL::41 7 63
-DEAL::41 8 65
-DEAL::41 9 75
-DEAL::42 0 0
-DEAL::42 1 20
-DEAL::42 2 23
-DEAL::42 3 31
-DEAL::42 4 35
-DEAL::42 5 36
-DEAL::42 6 48
-DEAL::42 7 55
-DEAL::42 8 91
-DEAL::42 9 96
-DEAL::43 0 11
-DEAL::43 1 19
-DEAL::43 2 31
-DEAL::43 3 35
-DEAL::43 4 39
-DEAL::43 5 51
-DEAL::43 6 79
-DEAL::43 7 91
-DEAL::43 8 99
-DEAL::44 0 4
-DEAL::44 1 24
-DEAL::44 2 29
-DEAL::44 3 44
-DEAL::44 4 49
-DEAL::44 5 69
-DEAL::45 0 15
-DEAL::45 1 29
-DEAL::45 2 41
-DEAL::45 3 51
-DEAL::45 4 59
-DEAL::45 5 61
-DEAL::45 6 65
-DEAL::45 7 69
-DEAL::45 8 71
-DEAL::45 9 99
-DEAL::46 0 0
-DEAL::46 1 8
-DEAL::46 2 11
-DEAL::46 3 15
-DEAL::46 4 16
-DEAL::46 5 31
-DEAL::46 6 55
-DEAL::46 7 60
-DEAL::46 8 83
-DEAL::46 9 96
-DEAL::47 0 3
-DEAL::47 1 31
-DEAL::47 2 35
-DEAL::47 3 51
-DEAL::47 4 55
-DEAL::47 5 71
-DEAL::47 6 75
-DEAL::47 7 91
-DEAL::47 8 95
-DEAL::48 0 0
-DEAL::48 1 1
-DEAL::48 2 25
-DEAL::48 3 36
-DEAL::48 4 41
-DEAL::48 5 49
-DEAL::48 6 64
-DEAL::48 7 69
-DEAL::48 8 84
-DEAL::48 9 96
-DEAL::49 0 49
-DEAL::49 1 99
-DEAL::50 0 0
-DEAL::50 1 4
-DEAL::50 2 16
-DEAL::50 3 31
-DEAL::50 4 36
-DEAL::50 5 51
-DEAL::50 6 59
-DEAL::50 7 64
-DEAL::50 8 75
-DEAL::50 9 99
-DEAL::51 0 3
-DEAL::51 1 11
-DEAL::51 2 15
-DEAL::51 3 31
-DEAL::51 4 35
-DEAL::51 5 51
-DEAL::51 6 55
-DEAL::51 7 71
-DEAL::51 8 75
-DEAL::52 0 0
-DEAL::52 1 1
-DEAL::52 2 5
-DEAL::52 3 8
-DEAL::52 4 16
-DEAL::52 5 20
-DEAL::52 6 33
-DEAL::52 7 56
-DEAL::52 8 61
-DEAL::52 9 85
-DEAL::53 0 1
-DEAL::53 1 15
-DEAL::53 2 31
-DEAL::53 3 59
-DEAL::53 4 61
-DEAL::53 5 65
-DEAL::53 6 69
-DEAL::53 7 71
-DEAL::53 8 79
-DEAL::53 9 89
-DEAL::54 0 4
-DEAL::54 1 19
-DEAL::54 2 24
-DEAL::54 3 44
-DEAL::54 4 79
-DEAL::54 5 99
-DEAL::55 0 19
-DEAL::55 1 31
-DEAL::55 2 35
-DEAL::55 3 39
-DEAL::55 4 51
-DEAL::55 5 59
-DEAL::55 6 71
-DEAL::55 7 79
-DEAL::55 8 91
-DEAL::56 0 0
-DEAL::56 1 5
-DEAL::56 2 41
-DEAL::56 3 48
-DEAL::56 4 60
-DEAL::56 5 61
-DEAL::56 6 65
-DEAL::56 7 73
-DEAL::56 8 76
-DEAL::56 9 96
-DEAL::57 0 5
-DEAL::57 1 13
-DEAL::57 2 21
-DEAL::57 3 51
-DEAL::57 4 61
-DEAL::57 5 63
-DEAL::57 6 75
-DEAL::57 7 85
-DEAL::57 8 91
-DEAL::57 9 95
-DEAL::58 0 4
-DEAL::58 1 11
-DEAL::58 2 16
-DEAL::58 3 24
-DEAL::58 4 39
-DEAL::58 5 55
-DEAL::58 6 56
-DEAL::58 7 59
-DEAL::58 8 71
-DEAL::58 9 80
-DEAL::59 0 39
-DEAL::59 1 59
-DEAL::59 2 99
-DEAL::60 0 9
-DEAL::60 1 16
-DEAL::60 2 20
-DEAL::60 3 24
-DEAL::60 4 45
-DEAL::60 5 61
-DEAL::60 6 64
-DEAL::60 7 69
-DEAL::60 8 81
-DEAL::60 9 96
-DEAL::61 0 1
-DEAL::61 1 5
-DEAL::61 2 11
-DEAL::61 3 35
-DEAL::61 4 43
-DEAL::61 5 65
-DEAL::61 6 75
-DEAL::61 7 81
-DEAL::61 8 91
-DEAL::61 9 93
-DEAL::62 0 0
-DEAL::62 1 20
-DEAL::62 2 31
-DEAL::62 3 35
-DEAL::62 4 36
-DEAL::62 5 43
-DEAL::62 6 55
-DEAL::62 7 68
-DEAL::62 8 71
-DEAL::62 9 76
-DEAL::63 0 19
-DEAL::63 1 31
-DEAL::63 2 51
-DEAL::63 3 59
-DEAL::63 4 71
-DEAL::63 5 79
-DEAL::63 6 91
-DEAL::63 7 95
-DEAL::63 8 99
-DEAL::64 0 9
-DEAL::64 1 24
-DEAL::64 2 49
-DEAL::64 3 64
-DEAL::64 4 84
-DEAL::64 5 89
-DEAL::65 0 1
-DEAL::65 1 5
-DEAL::65 2 11
-DEAL::65 3 19
-DEAL::65 4 21
-DEAL::65 5 31
-DEAL::65 6 49
-DEAL::65 7 55
-DEAL::65 8 79
-DEAL::65 9 89
-DEAL::66 0 0
-DEAL::66 1 15
-DEAL::66 2 55
-DEAL::66 3 56
-DEAL::66 4 60
-DEAL::66 5 63
-DEAL::66 6 71
-DEAL::66 7 76
-DEAL::66 8 88
-DEAL::66 9 91
-DEAL::67 0 11
-DEAL::67 1 23
-DEAL::67 2 31
-DEAL::67 3 35
-DEAL::67 4 55
-DEAL::67 5 71
-DEAL::67 6 75
-DEAL::67 7 91
-DEAL::67 8 95
-DEAL::68 0 29
-DEAL::68 1 36
-DEAL::68 2 41
-DEAL::68 3 44
-DEAL::68 4 49
-DEAL::68 5 60
-DEAL::68 6 64
-DEAL::68 7 76
-DEAL::68 8 81
-DEAL::68 9 85
-DEAL::69 0 19
-DEAL::69 1 29
-DEAL::69 2 49
-DEAL::69 3 69
-DEAL::69 4 79
-DEAL::69 5 99
-DEAL::70 0 11
-DEAL::70 1 15
-DEAL::70 2 19
-DEAL::70 3 24
-DEAL::70 4 40
-DEAL::70 5 76
-DEAL::70 6 79
-DEAL::70 7 84
-DEAL::70 8 91
-DEAL::70 9 96
-DEAL::71 0 11
-DEAL::71 1 15
-DEAL::71 2 31
-DEAL::71 3 35
-DEAL::71 4 55
-DEAL::71 5 71
-DEAL::71 6 75
-DEAL::71 7 83
-DEAL::71 8 91
-DEAL::72 0 0
-DEAL::72 1 1
-DEAL::72 2 5
-DEAL::72 3 20
-DEAL::72 4 28
-DEAL::72 5 41
-DEAL::72 6 53
-DEAL::72 7 56
-DEAL::72 8 85
-DEAL::72 9 96
-DEAL::73 0 1
-DEAL::73 1 11
-DEAL::73 2 25
-DEAL::73 3 39
-DEAL::73 4 41
-DEAL::73 5 49
-DEAL::73 6 59
-DEAL::73 7 69
-DEAL::73 8 71
-DEAL::73 9 75
-DEAL::74 0 24
-DEAL::74 1 99
-DEAL::75 0 11
-DEAL::75 1 31
-DEAL::75 2 39
-DEAL::75 3 51
-DEAL::75 4 59
-DEAL::75 5 75
-DEAL::75 6 79
-DEAL::75 7 91
-DEAL::75 8 99
-DEAL::76 0 0
-DEAL::76 1 1
-DEAL::76 2 5
-DEAL::76 3 21
-DEAL::76 4 28
-DEAL::76 5 36
-DEAL::76 6 53
-DEAL::76 7 56
-DEAL::76 8 60
-DEAL::76 9 65
-DEAL::77 0 1
-DEAL::77 1 5
-DEAL::77 2 31
-DEAL::77 3 33
-DEAL::77 4 61
-DEAL::77 5 75
-DEAL::77 6 83
-DEAL::77 7 85
-DEAL::77 8 91
-DEAL::77 9 95
-DEAL::78 0 4
-DEAL::78 1 11
-DEAL::78 2 15
-DEAL::78 3 19
-DEAL::78 4 39
-DEAL::78 5 40
-DEAL::78 6 51
-DEAL::78 7 56
-DEAL::78 8 84
-DEAL::78 9 96
-DEAL::79 0 19
-DEAL::79 1 79
-DEAL::79 2 99
-DEAL::80 0 21
-DEAL::80 1 29
-DEAL::80 2 41
-DEAL::80 3 44
-DEAL::80 4 56
-DEAL::80 5 60
-DEAL::80 6 76
-DEAL::80 7 84
-DEAL::80 8 85
-DEAL::80 9 89
-DEAL::81 0 5
-DEAL::81 1 23
-DEAL::81 2 35
-DEAL::81 3 41
-DEAL::81 4 51
-DEAL::81 5 61
-DEAL::81 6 65
-DEAL::81 7 71
-DEAL::81 8 73
-DEAL::81 9 75
-DEAL::82 0 0
-DEAL::82 1 11
-DEAL::82 2 16
-DEAL::82 3 20
-DEAL::82 4 35
-DEAL::82 5 55
-DEAL::82 6 63
-DEAL::82 7 71
-DEAL::82 8 76
-DEAL::82 9 88
-DEAL::83 0 11
-DEAL::83 1 31
-DEAL::83 2 39
-DEAL::83 3 55
-DEAL::83 4 59
-DEAL::83 5 71
-DEAL::83 6 79
-DEAL::83 7 91
-DEAL::83 8 99
-DEAL::84 0 9
-DEAL::84 1 24
-DEAL::84 2 49
-DEAL::84 3 64
-DEAL::84 4 84
-DEAL::84 5 89
-DEAL::85 0 9
-DEAL::85 1 39
-DEAL::85 2 45
-DEAL::85 3 61
-DEAL::85 4 69
-DEAL::85 5 71
-DEAL::85 6 81
-DEAL::85 7 91
-DEAL::85 8 95
-DEAL::85 9 99
-DEAL::86 0 0
-DEAL::86 1 15
-DEAL::86 2 16
-DEAL::86 3 31
-DEAL::86 4 36
-DEAL::86 5 43
-DEAL::86 6 51
-DEAL::86 7 55
-DEAL::86 8 60
-DEAL::86 9 68
-DEAL::87 0 11
-DEAL::87 1 31
-DEAL::87 2 35
-DEAL::87 3 43
-DEAL::87 4 51
-DEAL::87 5 55
-DEAL::87 6 71
-DEAL::87 7 75
-DEAL::87 8 95
-DEAL::88 0 9
-DEAL::88 1 16
-DEAL::88 2 20
-DEAL::88 3 21
-DEAL::88 4 24
-DEAL::88 5 29
-DEAL::88 6 44
-DEAL::88 7 45
-DEAL::88 8 76
-DEAL::88 9 81
-DEAL::89 0 9
-DEAL::89 1 39
-DEAL::89 2 49
-DEAL::89 3 59
-DEAL::89 4 89
-DEAL::89 5 99
-DEAL::90 0 4
-DEAL::90 1 36
-DEAL::90 2 39
-DEAL::90 3 44
-DEAL::90 4 51
-DEAL::90 5 55
-DEAL::90 6 56
-DEAL::90 7 71
-DEAL::90 8 80
-DEAL::90 9 99
-DEAL::91 0 15
-DEAL::91 1 31
-DEAL::91 2 35
-DEAL::91 3 51
-DEAL::91 4 55
-DEAL::91 5 63
-DEAL::91 6 71
-DEAL::91 7 75
-DEAL::91 8 91
-DEAL::92 0 0
-DEAL::92 1 5
-DEAL::92 2 20
-DEAL::92 3 36
-DEAL::92 4 41
-DEAL::92 5 48
-DEAL::92 6 73
-DEAL::92 7 81
-DEAL::92 8 85
-DEAL::92 9 96
-DEAL::93 0 11
-DEAL::93 1 19
-DEAL::93 2 29
-DEAL::93 3 35
-DEAL::93 4 39
-DEAL::93 5 41
-DEAL::93 6 49
-DEAL::93 7 51
-DEAL::93 8 81
-DEAL::93 9 85
-DEAL::94 0 4
-DEAL::94 1 19
-DEAL::94 2 24
-DEAL::94 3 44
-DEAL::94 4 79
-DEAL::94 5 99
-DEAL::95 0 11
-DEAL::95 1 15
-DEAL::95 2 19
-DEAL::95 3 51
-DEAL::95 4 59
-DEAL::95 5 71
-DEAL::95 6 79
-DEAL::95 7 91
-DEAL::95 8 99
-DEAL::96 0 0
-DEAL::96 1 5
-DEAL::96 2 8
-DEAL::96 3 16
-DEAL::96 4 33
-DEAL::96 5 60
-DEAL::96 6 61
-DEAL::96 7 65
-DEAL::96 8 81
-DEAL::96 9 96
-DEAL::97 0 1
-DEAL::97 1 3
-DEAL::97 2 5
-DEAL::97 3 31
-DEAL::97 4 41
-DEAL::97 5 53
-DEAL::97 6 71
-DEAL::97 7 75
-DEAL::97 8 85
-DEAL::97 9 95
-DEAL::98 0 0
-DEAL::98 1 19
-DEAL::98 2 36
-DEAL::98 3 51
-DEAL::98 4 64
-DEAL::98 5 75
-DEAL::98 6 84
-DEAL::98 7 91
-DEAL::98 8 96
-DEAL::98 9 99
-DEAL::99 0 99
+++ /dev/null
-
-DEAL::0 0 0
-DEAL::0 1 1
-DEAL::0 2 2
-DEAL::0 3 4
-DEAL::0 4 6
-DEAL::0 5 9
-DEAL::0 6 12
-DEAL::0 7 16
-DEAL::0 8 22
-DEAL::0 9 25
-DEAL::0 10 26
-DEAL::0 11 32
-DEAL::0 12 36
-DEAL::0 13 42
-DEAL::0 14 46
-DEAL::0 15 48
-DEAL::0 16 49
-DEAL::0 17 50
-DEAL::0 18 52
-DEAL::0 19 56
-DEAL::0 20 62
-DEAL::0 21 64
-DEAL::0 22 66
-DEAL::0 23 72
-DEAL::0 24 76
-DEAL::0 25 81
-DEAL::0 26 82
-DEAL::0 27 86
-DEAL::0 28 92
-DEAL::0 29 96
-DEAL::0 30 98
-DEAL::1 0 0
-DEAL::1 1 1
-DEAL::1 2 3
-DEAL::1 3 5
-DEAL::1 4 11
-DEAL::1 5 21
-DEAL::1 6 25
-DEAL::1 7 28
-DEAL::1 8 31
-DEAL::1 9 35
-DEAL::1 10 36
-DEAL::1 11 40
-DEAL::1 12 48
-DEAL::1 13 52
-DEAL::1 14 53
-DEAL::1 15 61
-DEAL::1 16 65
-DEAL::1 17 72
-DEAL::1 18 73
-DEAL::1 19 75
-DEAL::1 20 76
-DEAL::1 21 77
-DEAL::1 22 97
-DEAL::2 0 0
-DEAL::2 1 8
-DEAL::2 2 11
-DEAL::2 3 16
-DEAL::2 4 20
-DEAL::2 5 35
-DEAL::2 6 51
-DEAL::2 7 55
-DEAL::2 8 56
-DEAL::2 9 83
-DEAL::3 0 1
-DEAL::3 1 11
-DEAL::3 2 15
-DEAL::3 3 19
-DEAL::3 4 22
-DEAL::3 5 26
-DEAL::3 6 31
-DEAL::3 7 39
-DEAL::3 8 47
-DEAL::3 9 51
-DEAL::3 10 59
-DEAL::3 11 71
-DEAL::3 12 79
-DEAL::3 13 97
-DEAL::4 0 0
-DEAL::4 1 4
-DEAL::4 2 8
-DEAL::4 3 24
-DEAL::4 4 28
-DEAL::4 5 29
-DEAL::4 6 40
-DEAL::4 7 44
-DEAL::4 8 49
-DEAL::4 9 50
-DEAL::4 10 54
-DEAL::4 11 58
-DEAL::4 12 69
-DEAL::4 13 78
-DEAL::4 14 90
-DEAL::4 15 94
-DEAL::5 0 1
-DEAL::5 1 8
-DEAL::5 2 12
-DEAL::5 3 16
-DEAL::5 4 17
-DEAL::5 5 19
-DEAL::5 6 21
-DEAL::5 7 29
-DEAL::5 8 31
-DEAL::5 9 32
-DEAL::5 10 33
-DEAL::5 11 35
-DEAL::5 12 36
-DEAL::5 13 37
-DEAL::5 14 40
-DEAL::5 15 41
-DEAL::5 16 51
-DEAL::5 17 52
-DEAL::5 18 56
-DEAL::5 19 57
-DEAL::5 20 59
-DEAL::5 21 61
-DEAL::5 22 65
-DEAL::5 23 72
-DEAL::5 24 76
-DEAL::5 25 77
-DEAL::5 26 81
-DEAL::5 27 85
-DEAL::5 28 89
-DEAL::5 29 92
-DEAL::5 30 96
-DEAL::5 31 97
-DEAL::6 0 0
-DEAL::6 1 11
-DEAL::6 2 15
-DEAL::6 3 23
-DEAL::6 4 48
-DEAL::6 5 55
-DEAL::6 6 60
-DEAL::6 7 76
-DEAL::6 8 91
-DEAL::6 9 96
-DEAL::7 0 11
-DEAL::7 1 35
-DEAL::7 2 51
-DEAL::7 3 55
-DEAL::7 4 63
-DEAL::7 5 71
-DEAL::7 6 75
-DEAL::7 7 91
-DEAL::7 8 95
-DEAL::8 0 2
-DEAL::8 1 4
-DEAL::8 2 5
-DEAL::8 3 9
-DEAL::8 4 16
-DEAL::8 5 21
-DEAL::8 6 24
-DEAL::8 7 46
-DEAL::8 8 52
-DEAL::8 9 56
-DEAL::8 10 61
-DEAL::8 11 80
-DEAL::8 12 89
-DEAL::8 13 96
-DEAL::9 0 0
-DEAL::9 1 8
-DEAL::9 2 9
-DEAL::9 3 13
-DEAL::9 4 25
-DEAL::9 5 33
-DEAL::9 6 39
-DEAL::9 7 49
-DEAL::9 8 59
-DEAL::9 9 60
-DEAL::9 10 64
-DEAL::9 11 84
-DEAL::9 12 85
-DEAL::9 13 88
-DEAL::9 14 89
-DEAL::9 15 99
-DEAL::10 0 11
-DEAL::10 1 16
-DEAL::10 2 19
-DEAL::10 3 20
-DEAL::10 4 24
-DEAL::10 5 31
-DEAL::10 6 59
-DEAL::10 7 64
-DEAL::10 8 95
-DEAL::10 9 96
-DEAL::11 0 1
-DEAL::11 1 2
-DEAL::11 2 3
-DEAL::11 3 6
-DEAL::11 4 7
-DEAL::11 5 10
-DEAL::11 6 11
-DEAL::11 7 15
-DEAL::11 8 17
-DEAL::11 9 23
-DEAL::11 10 25
-DEAL::11 11 27
-DEAL::11 12 31
-DEAL::11 13 35
-DEAL::11 14 37
-DEAL::11 15 43
-DEAL::11 16 46
-DEAL::11 17 51
-DEAL::11 18 55
-DEAL::11 19 58
-DEAL::11 20 61
-DEAL::11 21 65
-DEAL::11 22 67
-DEAL::11 23 70
-DEAL::11 24 71
-DEAL::11 25 73
-DEAL::11 26 75
-DEAL::11 27 78
-DEAL::11 28 82
-DEAL::11 29 83
-DEAL::11 30 87
-DEAL::11 31 91
-DEAL::11 32 93
-DEAL::11 33 95
-DEAL::12 0 0
-DEAL::12 1 5
-DEAL::12 2 20
-DEAL::12 3 21
-DEAL::12 4 36
-DEAL::12 5 68
-DEAL::12 6 76
-DEAL::12 7 81
-DEAL::12 8 85
-DEAL::12 9 93
-DEAL::13 0 9
-DEAL::13 1 16
-DEAL::13 2 19
-DEAL::13 3 21
-DEAL::13 4 29
-DEAL::13 5 32
-DEAL::13 6 41
-DEAL::13 7 45
-DEAL::13 8 51
-DEAL::13 9 57
-DEAL::13 10 81
-DEAL::13 11 91
-DEAL::13 12 95
-DEAL::13 13 99
-DEAL::14 0 24
-DEAL::14 1 39
-DEAL::14 2 59
-DEAL::14 3 64
-DEAL::14 4 84
-DEAL::14 5 99
-DEAL::15 0 3
-DEAL::15 1 6
-DEAL::15 2 11
-DEAL::15 3 19
-DEAL::15 4 26
-DEAL::15 5 31
-DEAL::15 6 39
-DEAL::15 7 45
-DEAL::15 8 46
-DEAL::15 9 51
-DEAL::15 10 53
-DEAL::15 11 55
-DEAL::15 12 66
-DEAL::15 13 70
-DEAL::15 14 71
-DEAL::15 15 78
-DEAL::15 16 79
-DEAL::15 17 86
-DEAL::15 18 91
-DEAL::15 19 95
-DEAL::15 20 99
-DEAL::16 0 0
-DEAL::16 1 2
-DEAL::16 2 5
-DEAL::16 3 8
-DEAL::16 4 10
-DEAL::16 5 13
-DEAL::16 6 21
-DEAL::16 7 32
-DEAL::16 8 36
-DEAL::16 9 38
-DEAL::16 10 41
-DEAL::16 11 46
-DEAL::16 12 50
-DEAL::16 13 52
-DEAL::16 14 56
-DEAL::16 15 58
-DEAL::16 16 60
-DEAL::16 17 65
-DEAL::16 18 76
-DEAL::16 19 82
-DEAL::16 20 86
-DEAL::16 21 88
-DEAL::16 22 96
-DEAL::17 0 5
-DEAL::17 1 11
-DEAL::17 2 23
-DEAL::17 3 41
-DEAL::17 4 71
-DEAL::17 5 73
-DEAL::17 6 75
-DEAL::17 7 81
-DEAL::17 8 85
-DEAL::17 9 95
-DEAL::18 0 31
-DEAL::18 1 35
-DEAL::18 2 36
-DEAL::18 3 44
-DEAL::18 4 60
-DEAL::18 5 64
-DEAL::18 6 76
-DEAL::18 7 79
-DEAL::18 8 91
-DEAL::18 9 99
-DEAL::19 0 3
-DEAL::19 1 5
-DEAL::19 2 10
-DEAL::19 3 13
-DEAL::19 4 15
-DEAL::19 5 19
-DEAL::19 6 23
-DEAL::19 7 29
-DEAL::19 8 35
-DEAL::19 9 43
-DEAL::19 10 54
-DEAL::19 11 55
-DEAL::19 12 63
-DEAL::19 13 65
-DEAL::19 14 69
-DEAL::19 15 70
-DEAL::19 16 78
-DEAL::19 17 79
-DEAL::19 18 93
-DEAL::19 19 94
-DEAL::19 20 95
-DEAL::19 21 98
-DEAL::19 22 99
-DEAL::20 0 2
-DEAL::20 1 10
-DEAL::20 2 12
-DEAL::20 3 22
-DEAL::20 4 24
-DEAL::20 5 29
-DEAL::20 6 32
-DEAL::20 7 38
-DEAL::20 8 40
-DEAL::20 9 41
-DEAL::20 10 42
-DEAL::20 11 52
-DEAL::20 12 60
-DEAL::20 13 61
-DEAL::20 14 62
-DEAL::20 15 65
-DEAL::20 16 69
-DEAL::20 17 72
-DEAL::20 18 76
-DEAL::20 19 82
-DEAL::20 20 84
-DEAL::20 21 88
-DEAL::20 22 92
-DEAL::20 23 96
-DEAL::21 0 1
-DEAL::21 1 5
-DEAL::21 2 8
-DEAL::21 3 12
-DEAL::21 4 13
-DEAL::21 5 16
-DEAL::21 6 32
-DEAL::21 7 33
-DEAL::21 8 35
-DEAL::21 9 37
-DEAL::21 10 40
-DEAL::21 11 41
-DEAL::21 12 57
-DEAL::21 13 61
-DEAL::21 14 65
-DEAL::21 15 71
-DEAL::21 16 75
-DEAL::21 17 76
-DEAL::21 18 80
-DEAL::21 19 81
-DEAL::21 20 83
-DEAL::21 21 88
-DEAL::21 22 91
-DEAL::22 0 0
-DEAL::22 1 3
-DEAL::22 2 20
-DEAL::22 3 28
-DEAL::22 4 35
-DEAL::22 5 51
-DEAL::22 6 55
-DEAL::22 7 56
-DEAL::22 8 91
-DEAL::22 9 96
-DEAL::23 0 6
-DEAL::23 1 11
-DEAL::23 2 17
-DEAL::23 3 19
-DEAL::23 4 31
-DEAL::23 5 39
-DEAL::23 6 42
-DEAL::23 7 51
-DEAL::23 8 59
-DEAL::23 9 67
-DEAL::23 10 71
-DEAL::23 11 75
-DEAL::23 12 81
-DEAL::23 13 91
-DEAL::23 14 99
-DEAL::24 0 4
-DEAL::24 1 8
-DEAL::24 2 10
-DEAL::24 3 14
-DEAL::24 4 20
-DEAL::24 5 24
-DEAL::24 6 34
-DEAL::24 7 38
-DEAL::24 8 44
-DEAL::24 9 49
-DEAL::24 10 54
-DEAL::24 11 58
-DEAL::24 12 60
-DEAL::24 13 64
-DEAL::24 14 70
-DEAL::24 15 74
-DEAL::24 16 84
-DEAL::24 17 88
-DEAL::24 18 94
-DEAL::25 0 0
-DEAL::25 1 1
-DEAL::25 2 9
-DEAL::25 3 11
-DEAL::25 4 25
-DEAL::25 5 39
-DEAL::25 6 48
-DEAL::25 7 49
-DEAL::25 8 73
-DEAL::25 9 75
-DEAL::25 10 79
-DEAL::25 11 81
-DEAL::25 12 91
-DEAL::26 0 0
-DEAL::26 1 3
-DEAL::26 2 15
-DEAL::26 3 28
-DEAL::26 4 36
-DEAL::26 5 51
-DEAL::26 6 55
-DEAL::26 7 56
-DEAL::26 8 60
-DEAL::26 9 71
-DEAL::27 0 11
-DEAL::27 1 31
-DEAL::27 2 35
-DEAL::27 3 51
-DEAL::27 4 55
-DEAL::27 5 75
-DEAL::27 6 83
-DEAL::27 7 91
-DEAL::27 8 95
-DEAL::28 0 1
-DEAL::28 1 4
-DEAL::28 2 22
-DEAL::28 3 26
-DEAL::28 4 40
-DEAL::28 5 56
-DEAL::28 6 61
-DEAL::28 7 65
-DEAL::28 8 69
-DEAL::28 9 72
-DEAL::28 10 76
-DEAL::28 11 84
-DEAL::28 12 89
-DEAL::28 13 96
-DEAL::29 0 4
-DEAL::29 1 5
-DEAL::29 2 13
-DEAL::29 3 19
-DEAL::29 4 20
-DEAL::29 5 29
-DEAL::29 6 44
-DEAL::29 7 45
-DEAL::29 8 49
-DEAL::29 9 68
-DEAL::29 10 69
-DEAL::29 11 79
-DEAL::29 12 80
-DEAL::29 13 88
-DEAL::29 14 93
-DEAL::29 15 99
-DEAL::30 0 35
-DEAL::30 1 39
-DEAL::30 2 44
-DEAL::30 3 56
-DEAL::30 4 60
-DEAL::30 5 71
-DEAL::30 6 76
-DEAL::30 7 79
-DEAL::30 8 84
-DEAL::30 9 91
-DEAL::31 0 1
-DEAL::31 1 3
-DEAL::31 2 5
-DEAL::31 3 10
-DEAL::31 4 11
-DEAL::31 5 15
-DEAL::31 6 18
-DEAL::31 7 23
-DEAL::31 8 27
-DEAL::31 9 33
-DEAL::31 10 35
-DEAL::31 11 38
-DEAL::31 12 41
-DEAL::31 13 42
-DEAL::31 14 43
-DEAL::31 15 46
-DEAL::31 16 47
-DEAL::31 17 50
-DEAL::31 18 51
-DEAL::31 19 53
-DEAL::31 20 55
-DEAL::31 21 62
-DEAL::31 22 63
-DEAL::31 23 65
-DEAL::31 24 67
-DEAL::31 25 71
-DEAL::31 26 75
-DEAL::31 27 77
-DEAL::31 28 83
-DEAL::31 29 86
-DEAL::31 30 87
-DEAL::31 31 91
-DEAL::31 32 97
-DEAL::32 0 0
-DEAL::32 1 5
-DEAL::32 2 13
-DEAL::32 3 16
-DEAL::32 4 20
-DEAL::32 5 21
-DEAL::32 6 61
-DEAL::32 7 76
-DEAL::32 8 85
-DEAL::32 9 88
-DEAL::33 0 5
-DEAL::33 1 9
-DEAL::33 2 21
-DEAL::33 3 31
-DEAL::33 4 52
-DEAL::33 5 55
-DEAL::33 6 61
-DEAL::33 7 77
-DEAL::33 8 79
-DEAL::33 9 89
-DEAL::33 10 91
-DEAL::33 11 96
-DEAL::33 12 99
-DEAL::34 0 24
-DEAL::34 1 39
-DEAL::34 2 59
-DEAL::34 3 64
-DEAL::34 4 84
-DEAL::34 5 99
-DEAL::35 0 1
-DEAL::35 1 2
-DEAL::35 2 5
-DEAL::35 3 7
-DEAL::35 4 11
-DEAL::35 5 18
-DEAL::35 6 19
-DEAL::35 7 21
-DEAL::35 8 22
-DEAL::35 9 27
-DEAL::35 10 30
-DEAL::35 11 31
-DEAL::35 12 39
-DEAL::35 13 41
-DEAL::35 14 42
-DEAL::35 15 43
-DEAL::35 16 47
-DEAL::35 17 51
-DEAL::35 18 55
-DEAL::35 19 59
-DEAL::35 20 61
-DEAL::35 21 62
-DEAL::35 22 67
-DEAL::35 23 71
-DEAL::35 24 81
-DEAL::35 25 82
-DEAL::35 26 87
-DEAL::35 27 91
-DEAL::35 28 93
-DEAL::35 29 95
-DEAL::35 30 99
-DEAL::36 0 0
-DEAL::36 1 1
-DEAL::36 2 5
-DEAL::36 3 12
-DEAL::36 4 16
-DEAL::36 5 18
-DEAL::36 6 26
-DEAL::36 7 36
-DEAL::36 8 40
-DEAL::36 9 42
-DEAL::36 10 48
-DEAL::36 11 50
-DEAL::36 12 60
-DEAL::36 13 62
-DEAL::36 14 65
-DEAL::36 15 68
-DEAL::36 16 76
-DEAL::36 17 81
-DEAL::36 18 86
-DEAL::36 19 90
-DEAL::36 20 92
-DEAL::36 21 93
-DEAL::36 22 98
-DEAL::37 0 5
-DEAL::37 1 11
-DEAL::37 2 21
-DEAL::37 3 43
-DEAL::37 4 51
-DEAL::37 5 75
-DEAL::37 6 81
-DEAL::37 7 85
-DEAL::37 8 93
-DEAL::37 9 95
-DEAL::38 0 16
-DEAL::38 1 20
-DEAL::38 2 24
-DEAL::38 3 31
-DEAL::38 4 44
-DEAL::38 5 59
-DEAL::38 6 71
-DEAL::38 7 76
-DEAL::38 8 79
-DEAL::38 9 95
-DEAL::39 0 3
-DEAL::39 1 9
-DEAL::39 2 14
-DEAL::39 3 15
-DEAL::39 4 23
-DEAL::39 5 25
-DEAL::39 6 30
-DEAL::39 7 34
-DEAL::39 8 35
-DEAL::39 9 39
-DEAL::39 10 43
-DEAL::39 11 55
-DEAL::39 12 58
-DEAL::39 13 59
-DEAL::39 14 73
-DEAL::39 15 75
-DEAL::39 16 78
-DEAL::39 17 83
-DEAL::39 18 85
-DEAL::39 19 89
-DEAL::39 20 90
-DEAL::39 21 93
-DEAL::39 22 99
-DEAL::40 0 1
-DEAL::40 1 4
-DEAL::40 2 5
-DEAL::40 3 20
-DEAL::40 4 21
-DEAL::40 5 28
-DEAL::40 6 36
-DEAL::40 7 44
-DEAL::40 8 49
-DEAL::40 9 56
-DEAL::40 10 70
-DEAL::40 11 78
-DEAL::40 12 80
-DEAL::40 13 89
-DEAL::41 0 5
-DEAL::41 1 13
-DEAL::41 2 16
-DEAL::41 3 17
-DEAL::41 4 20
-DEAL::41 5 21
-DEAL::41 6 31
-DEAL::41 7 35
-DEAL::41 8 41
-DEAL::41 9 45
-DEAL::41 10 48
-DEAL::41 11 51
-DEAL::41 12 56
-DEAL::41 13 63
-DEAL::41 14 65
-DEAL::41 15 68
-DEAL::41 16 72
-DEAL::41 17 73
-DEAL::41 18 75
-DEAL::41 19 80
-DEAL::41 20 81
-DEAL::41 21 92
-DEAL::41 22 93
-DEAL::41 23 97
-DEAL::42 0 0
-DEAL::42 1 20
-DEAL::42 2 23
-DEAL::42 3 31
-DEAL::42 4 35
-DEAL::42 5 36
-DEAL::42 6 48
-DEAL::42 7 55
-DEAL::42 8 91
-DEAL::42 9 96
-DEAL::43 0 11
-DEAL::43 1 19
-DEAL::43 2 31
-DEAL::43 3 35
-DEAL::43 4 37
-DEAL::43 5 39
-DEAL::43 6 51
-DEAL::43 7 61
-DEAL::43 8 62
-DEAL::43 9 79
-DEAL::43 10 86
-DEAL::43 11 87
-DEAL::43 12 91
-DEAL::43 13 99
-DEAL::44 0 4
-DEAL::44 1 18
-DEAL::44 2 24
-DEAL::44 3 29
-DEAL::44 4 30
-DEAL::44 5 38
-DEAL::44 6 40
-DEAL::44 7 44
-DEAL::44 8 49
-DEAL::44 9 54
-DEAL::44 10 68
-DEAL::44 11 69
-DEAL::44 12 80
-DEAL::44 13 88
-DEAL::44 14 90
-DEAL::44 15 94
-DEAL::45 0 13
-DEAL::45 1 15
-DEAL::45 2 29
-DEAL::45 3 41
-DEAL::45 4 51
-DEAL::45 5 59
-DEAL::45 6 60
-DEAL::45 7 61
-DEAL::45 8 65
-DEAL::45 9 69
-DEAL::45 10 71
-DEAL::45 11 85
-DEAL::45 12 88
-DEAL::45 13 99
-DEAL::46 0 0
-DEAL::46 1 8
-DEAL::46 2 11
-DEAL::46 3 15
-DEAL::46 4 16
-DEAL::46 5 31
-DEAL::46 6 55
-DEAL::46 7 60
-DEAL::46 8 83
-DEAL::46 9 96
-DEAL::47 0 3
-DEAL::47 1 31
-DEAL::47 2 35
-DEAL::47 3 51
-DEAL::47 4 55
-DEAL::47 5 71
-DEAL::47 6 75
-DEAL::47 7 91
-DEAL::47 8 95
-DEAL::48 0 0
-DEAL::48 1 1
-DEAL::48 2 6
-DEAL::48 3 25
-DEAL::48 4 36
-DEAL::48 5 41
-DEAL::48 6 42
-DEAL::48 7 49
-DEAL::48 8 56
-DEAL::48 9 64
-DEAL::48 10 69
-DEAL::48 11 84
-DEAL::48 12 92
-DEAL::48 13 96
-DEAL::49 0 0
-DEAL::49 1 4
-DEAL::49 2 9
-DEAL::49 3 24
-DEAL::49 4 25
-DEAL::49 5 29
-DEAL::49 6 40
-DEAL::49 7 44
-DEAL::49 8 48
-DEAL::49 9 49
-DEAL::49 10 64
-DEAL::49 11 65
-DEAL::49 12 68
-DEAL::49 13 69
-DEAL::49 14 73
-DEAL::49 15 84
-DEAL::49 16 89
-DEAL::49 17 93
-DEAL::49 18 99
-DEAL::50 0 0
-DEAL::50 1 4
-DEAL::50 2 16
-DEAL::50 3 31
-DEAL::50 4 36
-DEAL::50 5 51
-DEAL::50 6 59
-DEAL::50 7 64
-DEAL::50 8 75
-DEAL::50 9 99
-DEAL::51 0 2
-DEAL::51 1 3
-DEAL::51 2 5
-DEAL::51 3 7
-DEAL::51 4 11
-DEAL::51 5 13
-DEAL::51 6 15
-DEAL::51 7 22
-DEAL::51 8 23
-DEAL::51 9 26
-DEAL::51 10 27
-DEAL::51 11 31
-DEAL::51 12 35
-DEAL::51 13 37
-DEAL::51 14 41
-DEAL::51 15 43
-DEAL::51 16 45
-DEAL::51 17 47
-DEAL::51 18 50
-DEAL::51 19 51
-DEAL::51 20 55
-DEAL::51 21 57
-DEAL::51 22 63
-DEAL::51 23 71
-DEAL::51 24 75
-DEAL::51 25 78
-DEAL::51 26 81
-DEAL::51 27 86
-DEAL::51 28 87
-DEAL::51 29 90
-DEAL::51 30 91
-DEAL::51 31 93
-DEAL::51 32 95
-DEAL::51 33 98
-DEAL::52 0 0
-DEAL::52 1 1
-DEAL::52 2 5
-DEAL::52 3 8
-DEAL::52 4 16
-DEAL::52 5 20
-DEAL::52 6 33
-DEAL::52 7 56
-DEAL::52 8 61
-DEAL::52 9 85
-DEAL::53 0 1
-DEAL::53 1 15
-DEAL::53 2 31
-DEAL::53 3 59
-DEAL::53 4 61
-DEAL::53 5 65
-DEAL::53 6 69
-DEAL::53 7 71
-DEAL::53 8 72
-DEAL::53 9 76
-DEAL::53 10 79
-DEAL::53 11 89
-DEAL::53 12 97
-DEAL::54 0 4
-DEAL::54 1 19
-DEAL::54 2 24
-DEAL::54 3 44
-DEAL::54 4 79
-DEAL::54 5 99
-DEAL::55 0 2
-DEAL::55 1 6
-DEAL::55 2 7
-DEAL::55 3 11
-DEAL::55 4 15
-DEAL::55 5 19
-DEAL::55 6 22
-DEAL::55 7 26
-DEAL::55 8 27
-DEAL::55 9 31
-DEAL::55 10 33
-DEAL::55 11 35
-DEAL::55 12 39
-DEAL::55 13 42
-DEAL::55 14 46
-DEAL::55 15 47
-DEAL::55 16 51
-DEAL::55 17 58
-DEAL::55 18 59
-DEAL::55 19 62
-DEAL::55 20 65
-DEAL::55 21 66
-DEAL::55 22 67
-DEAL::55 23 71
-DEAL::55 24 79
-DEAL::55 25 82
-DEAL::55 26 83
-DEAL::55 27 86
-DEAL::55 28 87
-DEAL::55 29 90
-DEAL::55 30 91
-DEAL::56 0 0
-DEAL::56 1 2
-DEAL::56 2 5
-DEAL::56 3 8
-DEAL::56 4 16
-DEAL::56 5 22
-DEAL::56 6 26
-DEAL::56 7 28
-DEAL::56 8 30
-DEAL::56 9 40
-DEAL::56 10 41
-DEAL::56 11 48
-DEAL::56 12 52
-DEAL::56 13 58
-DEAL::56 14 60
-DEAL::56 15 61
-DEAL::56 16 65
-DEAL::56 17 66
-DEAL::56 18 72
-DEAL::56 19 73
-DEAL::56 20 76
-DEAL::56 21 78
-DEAL::56 22 80
-DEAL::56 23 90
-DEAL::56 24 96
-DEAL::57 0 5
-DEAL::57 1 13
-DEAL::57 2 21
-DEAL::57 3 51
-DEAL::57 4 61
-DEAL::57 5 63
-DEAL::57 6 75
-DEAL::57 7 85
-DEAL::57 8 91
-DEAL::57 9 95
-DEAL::58 0 4
-DEAL::58 1 11
-DEAL::58 2 16
-DEAL::58 3 24
-DEAL::58 4 39
-DEAL::58 5 55
-DEAL::58 6 56
-DEAL::58 7 59
-DEAL::58 8 71
-DEAL::58 9 80
-DEAL::59 0 3
-DEAL::59 1 5
-DEAL::59 2 9
-DEAL::59 3 10
-DEAL::59 4 14
-DEAL::59 5 23
-DEAL::59 6 34
-DEAL::59 7 35
-DEAL::59 8 38
-DEAL::59 9 39
-DEAL::59 10 45
-DEAL::59 11 50
-DEAL::59 12 53
-DEAL::59 13 55
-DEAL::59 14 58
-DEAL::59 15 59
-DEAL::59 16 63
-DEAL::59 17 73
-DEAL::59 18 75
-DEAL::59 19 83
-DEAL::59 20 89
-DEAL::59 21 95
-DEAL::59 22 99
-DEAL::60 0 6
-DEAL::60 1 9
-DEAL::60 2 16
-DEAL::60 3 18
-DEAL::60 4 20
-DEAL::60 5 24
-DEAL::60 6 26
-DEAL::60 7 30
-DEAL::60 8 36
-DEAL::60 9 45
-DEAL::60 10 46
-DEAL::60 11 56
-DEAL::60 12 61
-DEAL::60 13 64
-DEAL::60 14 66
-DEAL::60 15 68
-DEAL::60 16 69
-DEAL::60 17 76
-DEAL::60 18 80
-DEAL::60 19 81
-DEAL::60 20 86
-DEAL::60 21 96
-DEAL::61 0 1
-DEAL::61 1 5
-DEAL::61 2 8
-DEAL::61 3 11
-DEAL::61 4 20
-DEAL::61 5 21
-DEAL::61 6 28
-DEAL::61 7 32
-DEAL::61 8 33
-DEAL::61 9 35
-DEAL::61 10 43
-DEAL::61 11 45
-DEAL::61 12 52
-DEAL::61 13 53
-DEAL::61 14 56
-DEAL::61 15 57
-DEAL::61 16 60
-DEAL::61 17 65
-DEAL::61 18 75
-DEAL::61 19 77
-DEAL::61 20 81
-DEAL::61 21 85
-DEAL::61 22 91
-DEAL::61 23 93
-DEAL::61 24 96
-DEAL::62 0 0
-DEAL::62 1 20
-DEAL::62 2 31
-DEAL::62 3 35
-DEAL::62 4 36
-DEAL::62 5 43
-DEAL::62 6 55
-DEAL::62 7 68
-DEAL::62 8 71
-DEAL::62 9 76
-DEAL::63 0 7
-DEAL::63 1 19
-DEAL::63 2 31
-DEAL::63 3 41
-DEAL::63 4 51
-DEAL::63 5 57
-DEAL::63 6 59
-DEAL::63 7 66
-DEAL::63 8 71
-DEAL::63 9 79
-DEAL::63 10 82
-DEAL::63 11 91
-DEAL::63 12 95
-DEAL::63 13 99
-DEAL::64 0 0
-DEAL::64 1 9
-DEAL::64 2 10
-DEAL::64 3 14
-DEAL::64 4 18
-DEAL::64 5 24
-DEAL::64 6 34
-DEAL::64 7 48
-DEAL::64 8 49
-DEAL::64 9 50
-DEAL::64 10 60
-DEAL::64 11 64
-DEAL::64 12 68
-DEAL::64 13 84
-DEAL::64 14 89
-DEAL::64 15 98
-DEAL::65 0 1
-DEAL::65 1 5
-DEAL::65 2 11
-DEAL::65 3 16
-DEAL::65 4 19
-DEAL::65 5 20
-DEAL::65 6 21
-DEAL::65 7 28
-DEAL::65 8 31
-DEAL::65 9 36
-DEAL::65 10 41
-DEAL::65 11 45
-DEAL::65 12 49
-DEAL::65 13 53
-DEAL::65 14 55
-DEAL::65 15 56
-DEAL::65 16 61
-DEAL::65 17 76
-DEAL::65 18 79
-DEAL::65 19 81
-DEAL::65 20 89
-DEAL::65 21 96
-DEAL::66 0 0
-DEAL::66 1 15
-DEAL::66 2 55
-DEAL::66 3 56
-DEAL::66 4 60
-DEAL::66 5 63
-DEAL::66 6 71
-DEAL::66 7 76
-DEAL::66 8 88
-DEAL::66 9 91
-DEAL::67 0 11
-DEAL::67 1 23
-DEAL::67 2 31
-DEAL::67 3 35
-DEAL::67 4 55
-DEAL::67 5 71
-DEAL::67 6 75
-DEAL::67 7 91
-DEAL::67 8 95
-DEAL::68 0 12
-DEAL::68 1 29
-DEAL::68 2 36
-DEAL::68 3 41
-DEAL::68 4 44
-DEAL::68 5 49
-DEAL::68 6 60
-DEAL::68 7 62
-DEAL::68 8 64
-DEAL::68 9 76
-DEAL::68 10 81
-DEAL::68 11 85
-DEAL::68 12 86
-DEAL::69 0 4
-DEAL::69 1 19
-DEAL::69 2 20
-DEAL::69 3 28
-DEAL::69 4 29
-DEAL::69 5 44
-DEAL::69 6 45
-DEAL::69 7 48
-DEAL::69 8 49
-DEAL::69 9 53
-DEAL::69 10 60
-DEAL::69 11 69
-DEAL::69 12 73
-DEAL::69 13 79
-DEAL::69 14 85
-DEAL::69 15 99
-DEAL::70 0 11
-DEAL::70 1 15
-DEAL::70 2 19
-DEAL::70 3 24
-DEAL::70 4 40
-DEAL::70 5 76
-DEAL::70 6 79
-DEAL::70 7 84
-DEAL::70 8 91
-DEAL::70 9 96
-DEAL::71 0 3
-DEAL::71 1 7
-DEAL::71 2 11
-DEAL::71 3 15
-DEAL::71 4 17
-DEAL::71 5 21
-DEAL::71 6 23
-DEAL::71 7 26
-DEAL::71 8 30
-DEAL::71 9 31
-DEAL::71 10 35
-DEAL::71 11 38
-DEAL::71 12 45
-DEAL::71 13 47
-DEAL::71 14 51
-DEAL::71 15 53
-DEAL::71 16 55
-DEAL::71 17 58
-DEAL::71 18 62
-DEAL::71 19 63
-DEAL::71 20 66
-DEAL::71 21 67
-DEAL::71 22 71
-DEAL::71 23 73
-DEAL::71 24 75
-DEAL::71 25 81
-DEAL::71 26 82
-DEAL::71 27 83
-DEAL::71 28 85
-DEAL::71 29 87
-DEAL::71 30 90
-DEAL::71 31 91
-DEAL::71 32 95
-DEAL::71 33 97
-DEAL::72 0 0
-DEAL::72 1 1
-DEAL::72 2 5
-DEAL::72 3 20
-DEAL::72 4 28
-DEAL::72 5 41
-DEAL::72 6 53
-DEAL::72 7 56
-DEAL::72 8 85
-DEAL::72 9 96
-DEAL::73 0 1
-DEAL::73 1 11
-DEAL::73 2 17
-DEAL::73 3 25
-DEAL::73 4 39
-DEAL::73 5 41
-DEAL::73 6 49
-DEAL::73 7 56
-DEAL::73 8 59
-DEAL::73 9 69
-DEAL::73 10 71
-DEAL::73 11 75
-DEAL::73 12 81
-DEAL::73 13 92
-DEAL::74 0 24
-DEAL::74 1 99
-DEAL::75 0 1
-DEAL::75 1 7
-DEAL::75 2 11
-DEAL::75 3 17
-DEAL::75 4 21
-DEAL::75 5 23
-DEAL::75 6 25
-DEAL::75 7 27
-DEAL::75 8 31
-DEAL::75 9 37
-DEAL::75 10 39
-DEAL::75 11 41
-DEAL::75 12 47
-DEAL::75 13 50
-DEAL::75 14 51
-DEAL::75 15 57
-DEAL::75 16 59
-DEAL::75 17 61
-DEAL::75 18 67
-DEAL::75 19 71
-DEAL::75 20 73
-DEAL::75 21 75
-DEAL::75 22 77
-DEAL::75 23 79
-DEAL::75 24 81
-DEAL::75 25 87
-DEAL::75 26 91
-DEAL::75 27 97
-DEAL::75 28 98
-DEAL::75 29 99
-DEAL::76 0 0
-DEAL::76 1 1
-DEAL::76 2 5
-DEAL::76 3 6
-DEAL::76 4 12
-DEAL::76 5 16
-DEAL::76 6 18
-DEAL::76 7 20
-DEAL::76 8 21
-DEAL::76 9 28
-DEAL::76 10 30
-DEAL::76 11 32
-DEAL::76 12 36
-DEAL::76 13 38
-DEAL::76 14 53
-DEAL::76 15 56
-DEAL::76 16 60
-DEAL::76 17 62
-DEAL::76 18 65
-DEAL::76 19 66
-DEAL::76 20 68
-DEAL::76 21 70
-DEAL::76 22 80
-DEAL::76 23 82
-DEAL::76 24 88
-DEAL::77 0 1
-DEAL::77 1 5
-DEAL::77 2 31
-DEAL::77 3 33
-DEAL::77 4 61
-DEAL::77 5 75
-DEAL::77 6 83
-DEAL::77 7 85
-DEAL::77 8 91
-DEAL::77 9 95
-DEAL::78 0 4
-DEAL::78 1 11
-DEAL::78 2 15
-DEAL::78 3 19
-DEAL::78 4 39
-DEAL::78 5 40
-DEAL::78 6 51
-DEAL::78 7 56
-DEAL::78 8 84
-DEAL::78 9 96
-DEAL::79 0 3
-DEAL::79 1 15
-DEAL::79 2 18
-DEAL::79 3 19
-DEAL::79 4 25
-DEAL::79 5 29
-DEAL::79 6 30
-DEAL::79 7 33
-DEAL::79 8 38
-DEAL::79 9 43
-DEAL::79 10 53
-DEAL::79 11 54
-DEAL::79 12 55
-DEAL::79 13 63
-DEAL::79 14 65
-DEAL::79 15 69
-DEAL::79 16 70
-DEAL::79 17 75
-DEAL::79 18 79
-DEAL::79 19 83
-DEAL::79 20 94
-DEAL::79 21 95
-DEAL::79 22 99
-DEAL::80 0 8
-DEAL::80 1 21
-DEAL::80 2 29
-DEAL::80 3 40
-DEAL::80 4 41
-DEAL::80 5 44
-DEAL::80 6 56
-DEAL::80 7 58
-DEAL::80 8 60
-DEAL::80 9 76
-DEAL::80 10 84
-DEAL::80 11 85
-DEAL::80 12 89
-DEAL::80 13 90
-DEAL::81 0 0
-DEAL::81 1 5
-DEAL::81 2 12
-DEAL::81 3 13
-DEAL::81 4 17
-DEAL::81 5 21
-DEAL::81 6 23
-DEAL::81 7 25
-DEAL::81 8 35
-DEAL::81 9 36
-DEAL::81 10 37
-DEAL::81 11 41
-DEAL::81 12 51
-DEAL::81 13 60
-DEAL::81 14 61
-DEAL::81 15 65
-DEAL::81 16 68
-DEAL::81 17 71
-DEAL::81 18 73
-DEAL::81 19 75
-DEAL::81 20 85
-DEAL::81 21 88
-DEAL::81 22 92
-DEAL::81 23 93
-DEAL::81 24 96
-DEAL::82 0 0
-DEAL::82 1 11
-DEAL::82 2 16
-DEAL::82 3 20
-DEAL::82 4 35
-DEAL::82 5 55
-DEAL::82 6 63
-DEAL::82 7 71
-DEAL::82 8 76
-DEAL::82 9 88
-DEAL::83 0 2
-DEAL::83 1 11
-DEAL::83 2 21
-DEAL::83 3 27
-DEAL::83 4 31
-DEAL::83 5 39
-DEAL::83 6 46
-DEAL::83 7 55
-DEAL::83 8 59
-DEAL::83 9 71
-DEAL::83 10 77
-DEAL::83 11 79
-DEAL::83 12 91
-DEAL::83 13 99
-DEAL::84 0 9
-DEAL::84 1 14
-DEAL::84 2 20
-DEAL::84 3 24
-DEAL::84 4 28
-DEAL::84 5 30
-DEAL::84 6 34
-DEAL::84 7 48
-DEAL::84 8 49
-DEAL::84 9 64
-DEAL::84 10 70
-DEAL::84 11 78
-DEAL::84 12 80
-DEAL::84 13 84
-DEAL::84 14 89
-DEAL::84 15 98
-DEAL::85 0 5
-DEAL::85 1 9
-DEAL::85 2 12
-DEAL::85 3 17
-DEAL::85 4 32
-DEAL::85 5 37
-DEAL::85 6 39
-DEAL::85 7 45
-DEAL::85 8 52
-DEAL::85 9 57
-DEAL::85 10 61
-DEAL::85 11 68
-DEAL::85 12 69
-DEAL::85 13 71
-DEAL::85 14 72
-DEAL::85 15 77
-DEAL::85 16 80
-DEAL::85 17 81
-DEAL::85 18 91
-DEAL::85 19 92
-DEAL::85 20 93
-DEAL::85 21 95
-DEAL::85 22 97
-DEAL::85 23 99
-DEAL::86 0 0
-DEAL::86 1 15
-DEAL::86 2 16
-DEAL::86 3 31
-DEAL::86 4 36
-DEAL::86 5 43
-DEAL::86 6 51
-DEAL::86 7 55
-DEAL::86 8 60
-DEAL::86 9 68
-DEAL::87 0 11
-DEAL::87 1 31
-DEAL::87 2 35
-DEAL::87 3 43
-DEAL::87 4 51
-DEAL::87 5 55
-DEAL::87 6 71
-DEAL::87 7 75
-DEAL::87 8 95
-DEAL::88 0 9
-DEAL::88 1 16
-DEAL::88 2 20
-DEAL::88 3 21
-DEAL::88 4 24
-DEAL::88 5 29
-DEAL::88 6 32
-DEAL::88 7 44
-DEAL::88 8 45
-DEAL::88 9 66
-DEAL::88 10 76
-DEAL::88 11 81
-DEAL::88 12 82
-DEAL::89 0 5
-DEAL::89 1 8
-DEAL::89 2 9
-DEAL::89 3 28
-DEAL::89 4 33
-DEAL::89 5 39
-DEAL::89 6 40
-DEAL::89 7 49
-DEAL::89 8 53
-DEAL::89 9 59
-DEAL::89 10 64
-DEAL::89 11 65
-DEAL::89 12 80
-DEAL::89 13 84
-DEAL::89 14 89
-DEAL::89 15 99
-DEAL::90 0 4
-DEAL::90 1 36
-DEAL::90 2 39
-DEAL::90 3 44
-DEAL::90 4 51
-DEAL::90 5 55
-DEAL::90 6 56
-DEAL::90 7 71
-DEAL::90 8 80
-DEAL::90 9 99
-DEAL::91 0 6
-DEAL::91 1 7
-DEAL::91 2 11
-DEAL::91 3 13
-DEAL::91 4 15
-DEAL::91 5 18
-DEAL::91 6 21
-DEAL::91 7 22
-DEAL::91 8 23
-DEAL::91 9 25
-DEAL::91 10 27
-DEAL::91 11 30
-DEAL::91 12 31
-DEAL::91 13 33
-DEAL::91 14 35
-DEAL::91 15 42
-DEAL::91 16 43
-DEAL::91 17 47
-DEAL::91 18 51
-DEAL::91 19 55
-DEAL::91 20 57
-DEAL::91 21 61
-DEAL::91 22 63
-DEAL::91 23 66
-DEAL::91 24 67
-DEAL::91 25 70
-DEAL::91 26 71
-DEAL::91 27 75
-DEAL::91 28 77
-DEAL::91 29 83
-DEAL::91 30 85
-DEAL::91 31 91
-DEAL::91 32 95
-DEAL::91 33 98
-DEAL::92 0 0
-DEAL::92 1 5
-DEAL::92 2 20
-DEAL::92 3 36
-DEAL::92 4 41
-DEAL::92 5 48
-DEAL::92 6 73
-DEAL::92 7 81
-DEAL::92 8 85
-DEAL::92 9 96
-DEAL::93 0 11
-DEAL::93 1 12
-DEAL::93 2 19
-DEAL::93 3 29
-DEAL::93 4 35
-DEAL::93 5 36
-DEAL::93 6 37
-DEAL::93 7 39
-DEAL::93 8 41
-DEAL::93 9 49
-DEAL::93 10 51
-DEAL::93 11 61
-DEAL::93 12 81
-DEAL::93 13 85
-DEAL::94 0 4
-DEAL::94 1 19
-DEAL::94 2 24
-DEAL::94 3 44
-DEAL::94 4 79
-DEAL::94 5 99
-DEAL::95 0 7
-DEAL::95 1 10
-DEAL::95 2 11
-DEAL::95 3 13
-DEAL::95 4 15
-DEAL::95 5 17
-DEAL::95 6 19
-DEAL::95 7 27
-DEAL::95 8 35
-DEAL::95 9 37
-DEAL::95 10 38
-DEAL::95 11 47
-DEAL::95 12 51
-DEAL::95 13 57
-DEAL::95 14 59
-DEAL::95 15 63
-DEAL::95 16 67
-DEAL::95 17 71
-DEAL::95 18 77
-DEAL::95 19 79
-DEAL::95 20 85
-DEAL::95 21 87
-DEAL::95 22 91
-DEAL::95 23 97
-DEAL::95 24 99
-DEAL::96 0 0
-DEAL::96 1 5
-DEAL::96 2 6
-DEAL::96 3 8
-DEAL::96 4 10
-DEAL::96 5 16
-DEAL::96 6 20
-DEAL::96 7 22
-DEAL::96 8 28
-DEAL::96 9 33
-DEAL::96 10 42
-DEAL::96 11 46
-DEAL::96 12 48
-DEAL::96 13 56
-DEAL::96 14 60
-DEAL::96 15 61
-DEAL::96 16 65
-DEAL::96 17 70
-DEAL::96 18 72
-DEAL::96 19 78
-DEAL::96 20 81
-DEAL::96 21 92
-DEAL::96 22 96
-DEAL::96 23 98
-DEAL::97 0 1
-DEAL::97 1 3
-DEAL::97 2 5
-DEAL::97 3 31
-DEAL::97 4 41
-DEAL::97 5 53
-DEAL::97 6 71
-DEAL::97 7 75
-DEAL::97 8 85
-DEAL::97 9 95
-DEAL::98 0 0
-DEAL::98 1 19
-DEAL::98 2 36
-DEAL::98 3 51
-DEAL::98 4 64
-DEAL::98 5 75
-DEAL::98 6 84
-DEAL::98 7 91
-DEAL::98 8 96
-DEAL::98 9 99
-DEAL::99 0 9
-DEAL::99 1 13
-DEAL::99 2 14
-DEAL::99 3 15
-DEAL::99 4 18
-DEAL::99 5 19
-DEAL::99 6 23
-DEAL::99 7 29
-DEAL::99 8 33
-DEAL::99 9 34
-DEAL::99 10 35
-DEAL::99 11 39
-DEAL::99 12 43
-DEAL::99 13 45
-DEAL::99 14 49
-DEAL::99 15 50
-DEAL::99 16 54
-DEAL::99 17 59
-DEAL::99 18 63
-DEAL::99 19 69
-DEAL::99 20 74
-DEAL::99 21 75
-DEAL::99 22 79
-DEAL::99 23 83
-DEAL::99 24 85
-DEAL::99 25 89
-DEAL::99 26 90
-DEAL::99 27 94
-DEAL::99 28 95
-DEAL::99 29 98
-DEAL::99 30 99
+++ /dev/null
-
-0 0
-1 0
-2 0
-4 0
-6 0
-9 0
-12 0
-16 0
-22 0
-25 0
-26 0
-32 0
-36 0
-42 0
-46 0
-48 0
-49 0
-50 0
-52 0
-56 0
-62 0
-64 0
-66 0
-72 0
-76 0
-81 0
-82 0
-86 0
-92 0
-96 0
-98 0
-0 -1
-1 -1
-3 -1
-5 -1
-11 -1
-21 -1
-25 -1
-28 -1
-31 -1
-35 -1
-36 -1
-40 -1
-48 -1
-52 -1
-53 -1
-61 -1
-65 -1
-72 -1
-73 -1
-75 -1
-76 -1
-77 -1
-97 -1
-0 -2
-8 -2
-11 -2
-16 -2
-20 -2
-35 -2
-51 -2
-55 -2
-56 -2
-83 -2
-1 -3
-11 -3
-15 -3
-19 -3
-22 -3
-26 -3
-31 -3
-39 -3
-47 -3
-51 -3
-59 -3
-71 -3
-79 -3
-97 -3
-0 -4
-4 -4
-8 -4
-24 -4
-28 -4
-29 -4
-40 -4
-44 -4
-49 -4
-50 -4
-54 -4
-58 -4
-69 -4
-78 -4
-90 -4
-94 -4
-1 -5
-8 -5
-12 -5
-16 -5
-17 -5
-19 -5
-21 -5
-29 -5
-31 -5
-32 -5
-33 -5
-35 -5
-36 -5
-37 -5
-40 -5
-41 -5
-51 -5
-52 -5
-56 -5
-57 -5
-59 -5
-61 -5
-65 -5
-72 -5
-76 -5
-77 -5
-81 -5
-85 -5
-89 -5
-92 -5
-96 -5
-97 -5
-0 -6
-11 -6
-15 -6
-23 -6
-48 -6
-55 -6
-60 -6
-76 -6
-91 -6
-96 -6
-11 -7
-35 -7
-51 -7
-55 -7
-63 -7
-71 -7
-75 -7
-91 -7
-95 -7
-2 -8
-4 -8
-5 -8
-9 -8
-16 -8
-21 -8
-24 -8
-46 -8
-52 -8
-56 -8
-61 -8
-80 -8
-89 -8
-96 -8
-0 -9
-8 -9
-9 -9
-13 -9
-25 -9
-33 -9
-39 -9
-49 -9
-59 -9
-60 -9
-64 -9
-84 -9
-85 -9
-88 -9
-89 -9
-99 -9
-11 -10
-16 -10
-19 -10
-20 -10
-24 -10
-31 -10
-59 -10
-64 -10
-95 -10
-96 -10
-1 -11
-2 -11
-3 -11
-6 -11
-7 -11
-10 -11
-11 -11
-15 -11
-17 -11
-23 -11
-25 -11
-27 -11
-31 -11
-35 -11
-37 -11
-43 -11
-46 -11
-51 -11
-55 -11
-58 -11
-61 -11
-65 -11
-67 -11
-70 -11
-71 -11
-73 -11
-75 -11
-78 -11
-82 -11
-83 -11
-87 -11
-91 -11
-93 -11
-95 -11
-0 -12
-5 -12
-20 -12
-21 -12
-36 -12
-68 -12
-76 -12
-81 -12
-85 -12
-93 -12
-9 -13
-16 -13
-19 -13
-21 -13
-29 -13
-32 -13
-41 -13
-45 -13
-51 -13
-57 -13
-81 -13
-91 -13
-95 -13
-99 -13
-24 -14
-39 -14
-59 -14
-64 -14
-84 -14
-99 -14
-3 -15
-6 -15
-11 -15
-19 -15
-26 -15
-31 -15
-39 -15
-45 -15
-46 -15
-51 -15
-53 -15
-55 -15
-66 -15
-70 -15
-71 -15
-78 -15
-79 -15
-86 -15
-91 -15
-95 -15
-99 -15
-0 -16
-2 -16
-5 -16
-8 -16
-10 -16
-13 -16
-21 -16
-32 -16
-36 -16
-38 -16
-41 -16
-46 -16
-50 -16
-52 -16
-56 -16
-58 -16
-60 -16
-65 -16
-76 -16
-82 -16
-86 -16
-88 -16
-96 -16
-5 -17
-11 -17
-23 -17
-41 -17
-71 -17
-73 -17
-75 -17
-81 -17
-85 -17
-95 -17
-31 -18
-35 -18
-36 -18
-44 -18
-60 -18
-64 -18
-76 -18
-79 -18
-91 -18
-99 -18
-3 -19
-5 -19
-10 -19
-13 -19
-15 -19
-19 -19
-23 -19
-29 -19
-35 -19
-43 -19
-54 -19
-55 -19
-63 -19
-65 -19
-69 -19
-70 -19
-78 -19
-79 -19
-93 -19
-94 -19
-95 -19
-98 -19
-99 -19
-2 -20
-10 -20
-12 -20
-22 -20
-24 -20
-29 -20
-32 -20
-38 -20
-40 -20
-41 -20
-42 -20
-52 -20
-60 -20
-61 -20
-62 -20
-65 -20
-69 -20
-72 -20
-76 -20
-82 -20
-84 -20
-88 -20
-92 -20
-96 -20
-1 -21
-5 -21
-8 -21
-12 -21
-13 -21
-16 -21
-32 -21
-33 -21
-35 -21
-37 -21
-40 -21
-41 -21
-57 -21
-61 -21
-65 -21
-71 -21
-75 -21
-76 -21
-80 -21
-81 -21
-83 -21
-88 -21
-91 -21
-0 -22
-3 -22
-20 -22
-28 -22
-35 -22
-51 -22
-55 -22
-56 -22
-91 -22
-96 -22
-6 -23
-11 -23
-17 -23
-19 -23
-31 -23
-39 -23
-42 -23
-51 -23
-59 -23
-67 -23
-71 -23
-75 -23
-81 -23
-91 -23
-99 -23
-4 -24
-8 -24
-10 -24
-14 -24
-20 -24
-24 -24
-34 -24
-38 -24
-44 -24
-49 -24
-54 -24
-58 -24
-60 -24
-64 -24
-70 -24
-74 -24
-84 -24
-88 -24
-94 -24
-0 -25
-1 -25
-9 -25
-11 -25
-25 -25
-39 -25
-48 -25
-49 -25
-73 -25
-75 -25
-79 -25
-81 -25
-91 -25
-0 -26
-3 -26
-15 -26
-28 -26
-36 -26
-51 -26
-55 -26
-56 -26
-60 -26
-71 -26
-11 -27
-31 -27
-35 -27
-51 -27
-55 -27
-75 -27
-83 -27
-91 -27
-95 -27
-1 -28
-4 -28
-22 -28
-26 -28
-40 -28
-56 -28
-61 -28
-65 -28
-69 -28
-72 -28
-76 -28
-84 -28
-89 -28
-96 -28
-4 -29
-5 -29
-13 -29
-19 -29
-20 -29
-29 -29
-44 -29
-45 -29
-49 -29
-68 -29
-69 -29
-79 -29
-80 -29
-88 -29
-93 -29
-99 -29
-35 -30
-39 -30
-44 -30
-56 -30
-60 -30
-71 -30
-76 -30
-79 -30
-84 -30
-91 -30
-1 -31
-3 -31
-5 -31
-10 -31
-11 -31
-15 -31
-18 -31
-23 -31
-27 -31
-33 -31
-35 -31
-38 -31
-41 -31
-42 -31
-43 -31
-46 -31
-47 -31
-50 -31
-51 -31
-53 -31
-55 -31
-62 -31
-63 -31
-65 -31
-67 -31
-71 -31
-75 -31
-77 -31
-83 -31
-86 -31
-87 -31
-91 -31
-97 -31
-0 -32
-5 -32
-13 -32
-16 -32
-20 -32
-21 -32
-61 -32
-76 -32
-85 -32
-88 -32
-5 -33
-9 -33
-21 -33
-31 -33
-52 -33
-55 -33
-61 -33
-77 -33
-79 -33
-89 -33
-91 -33
-96 -33
-99 -33
-24 -34
-39 -34
-59 -34
-64 -34
-84 -34
-99 -34
-1 -35
-2 -35
-5 -35
-7 -35
-11 -35
-18 -35
-19 -35
-21 -35
-22 -35
-27 -35
-30 -35
-31 -35
-39 -35
-41 -35
-42 -35
-43 -35
-47 -35
-51 -35
-55 -35
-59 -35
-61 -35
-62 -35
-67 -35
-71 -35
-81 -35
-82 -35
-87 -35
-91 -35
-93 -35
-95 -35
-99 -35
-0 -36
-1 -36
-5 -36
-12 -36
-16 -36
-18 -36
-26 -36
-36 -36
-40 -36
-42 -36
-48 -36
-50 -36
-60 -36
-62 -36
-65 -36
-68 -36
-76 -36
-81 -36
-86 -36
-90 -36
-92 -36
-93 -36
-98 -36
-5 -37
-11 -37
-21 -37
-43 -37
-51 -37
-75 -37
-81 -37
-85 -37
-93 -37
-95 -37
-16 -38
-20 -38
-24 -38
-31 -38
-44 -38
-59 -38
-71 -38
-76 -38
-79 -38
-95 -38
-3 -39
-9 -39
-14 -39
-15 -39
-23 -39
-25 -39
-30 -39
-34 -39
-35 -39
-39 -39
-43 -39
-55 -39
-58 -39
-59 -39
-73 -39
-75 -39
-78 -39
-83 -39
-85 -39
-89 -39
-90 -39
-93 -39
-99 -39
-1 -40
-4 -40
-5 -40
-20 -40
-21 -40
-28 -40
-36 -40
-44 -40
-49 -40
-56 -40
-70 -40
-78 -40
-80 -40
-89 -40
-5 -41
-13 -41
-16 -41
-17 -41
-20 -41
-21 -41
-31 -41
-35 -41
-41 -41
-45 -41
-48 -41
-51 -41
-56 -41
-63 -41
-65 -41
-68 -41
-72 -41
-73 -41
-75 -41
-80 -41
-81 -41
-92 -41
-93 -41
-97 -41
-0 -42
-20 -42
-23 -42
-31 -42
-35 -42
-36 -42
-48 -42
-55 -42
-91 -42
-96 -42
-11 -43
-19 -43
-31 -43
-35 -43
-37 -43
-39 -43
-51 -43
-61 -43
-62 -43
-79 -43
-86 -43
-87 -43
-91 -43
-99 -43
-4 -44
-18 -44
-24 -44
-29 -44
-30 -44
-38 -44
-40 -44
-44 -44
-49 -44
-54 -44
-68 -44
-69 -44
-80 -44
-88 -44
-90 -44
-94 -44
-13 -45
-15 -45
-29 -45
-41 -45
-51 -45
-59 -45
-60 -45
-61 -45
-65 -45
-69 -45
-71 -45
-85 -45
-88 -45
-99 -45
-0 -46
-8 -46
-11 -46
-15 -46
-16 -46
-31 -46
-55 -46
-60 -46
-83 -46
-96 -46
-3 -47
-31 -47
-35 -47
-51 -47
-55 -47
-71 -47
-75 -47
-91 -47
-95 -47
-0 -48
-1 -48
-6 -48
-25 -48
-36 -48
-41 -48
-42 -48
-49 -48
-56 -48
-64 -48
-69 -48
-84 -48
-92 -48
-96 -48
-0 -49
-4 -49
-9 -49
-24 -49
-25 -49
-29 -49
-40 -49
-44 -49
-48 -49
-49 -49
-64 -49
-65 -49
-68 -49
-69 -49
-73 -49
-84 -49
-89 -49
-93 -49
-99 -49
-0 -50
-4 -50
-16 -50
-31 -50
-36 -50
-51 -50
-59 -50
-64 -50
-75 -50
-99 -50
-2 -51
-3 -51
-5 -51
-7 -51
-11 -51
-13 -51
-15 -51
-22 -51
-23 -51
-26 -51
-27 -51
-31 -51
-35 -51
-37 -51
-41 -51
-43 -51
-45 -51
-47 -51
-50 -51
-51 -51
-55 -51
-57 -51
-63 -51
-71 -51
-75 -51
-78 -51
-81 -51
-86 -51
-87 -51
-90 -51
-91 -51
-93 -51
-95 -51
-98 -51
-0 -52
-1 -52
-5 -52
-8 -52
-16 -52
-20 -52
-33 -52
-56 -52
-61 -52
-85 -52
-1 -53
-15 -53
-31 -53
-59 -53
-61 -53
-65 -53
-69 -53
-71 -53
-72 -53
-76 -53
-79 -53
-89 -53
-97 -53
-4 -54
-19 -54
-24 -54
-44 -54
-79 -54
-99 -54
-2 -55
-6 -55
-7 -55
-11 -55
-15 -55
-19 -55
-22 -55
-26 -55
-27 -55
-31 -55
-33 -55
-35 -55
-39 -55
-42 -55
-46 -55
-47 -55
-51 -55
-58 -55
-59 -55
-62 -55
-65 -55
-66 -55
-67 -55
-71 -55
-79 -55
-82 -55
-83 -55
-86 -55
-87 -55
-90 -55
-91 -55
-0 -56
-2 -56
-5 -56
-8 -56
-16 -56
-22 -56
-26 -56
-28 -56
-30 -56
-40 -56
-41 -56
-48 -56
-52 -56
-58 -56
-60 -56
-61 -56
-65 -56
-66 -56
-72 -56
-73 -56
-76 -56
-78 -56
-80 -56
-90 -56
-96 -56
-5 -57
-13 -57
-21 -57
-51 -57
-61 -57
-63 -57
-75 -57
-85 -57
-91 -57
-95 -57
-4 -58
-11 -58
-16 -58
-24 -58
-39 -58
-55 -58
-56 -58
-59 -58
-71 -58
-80 -58
-3 -59
-5 -59
-9 -59
-10 -59
-14 -59
-23 -59
-34 -59
-35 -59
-38 -59
-39 -59
-45 -59
-50 -59
-53 -59
-55 -59
-58 -59
-59 -59
-63 -59
-73 -59
-75 -59
-83 -59
-89 -59
-95 -59
-99 -59
-6 -60
-9 -60
-16 -60
-18 -60
-20 -60
-24 -60
-26 -60
-30 -60
-36 -60
-45 -60
-46 -60
-56 -60
-61 -60
-64 -60
-66 -60
-68 -60
-69 -60
-76 -60
-80 -60
-81 -60
-86 -60
-96 -60
-1 -61
-5 -61
-8 -61
-11 -61
-20 -61
-21 -61
-28 -61
-32 -61
-33 -61
-35 -61
-43 -61
-45 -61
-52 -61
-53 -61
-56 -61
-57 -61
-60 -61
-65 -61
-75 -61
-77 -61
-81 -61
-85 -61
-91 -61
-93 -61
-96 -61
-0 -62
-20 -62
-31 -62
-35 -62
-36 -62
-43 -62
-55 -62
-68 -62
-71 -62
-76 -62
-7 -63
-19 -63
-31 -63
-41 -63
-51 -63
-57 -63
-59 -63
-66 -63
-71 -63
-79 -63
-82 -63
-91 -63
-95 -63
-99 -63
-0 -64
-9 -64
-10 -64
-14 -64
-18 -64
-24 -64
-34 -64
-48 -64
-49 -64
-50 -64
-60 -64
-64 -64
-68 -64
-84 -64
-89 -64
-98 -64
-1 -65
-5 -65
-11 -65
-16 -65
-19 -65
-20 -65
-21 -65
-28 -65
-31 -65
-36 -65
-41 -65
-45 -65
-49 -65
-53 -65
-55 -65
-56 -65
-61 -65
-76 -65
-79 -65
-81 -65
-89 -65
-96 -65
-0 -66
-15 -66
-55 -66
-56 -66
-60 -66
-63 -66
-71 -66
-76 -66
-88 -66
-91 -66
-11 -67
-23 -67
-31 -67
-35 -67
-55 -67
-71 -67
-75 -67
-91 -67
-95 -67
-12 -68
-29 -68
-36 -68
-41 -68
-44 -68
-49 -68
-60 -68
-62 -68
-64 -68
-76 -68
-81 -68
-85 -68
-86 -68
-4 -69
-19 -69
-20 -69
-28 -69
-29 -69
-44 -69
-45 -69
-48 -69
-49 -69
-53 -69
-60 -69
-69 -69
-73 -69
-79 -69
-85 -69
-99 -69
-11 -70
-15 -70
-19 -70
-24 -70
-40 -70
-76 -70
-79 -70
-84 -70
-91 -70
-96 -70
-3 -71
-7 -71
-11 -71
-15 -71
-17 -71
-21 -71
-23 -71
-26 -71
-30 -71
-31 -71
-35 -71
-38 -71
-45 -71
-47 -71
-51 -71
-53 -71
-55 -71
-58 -71
-62 -71
-63 -71
-66 -71
-67 -71
-71 -71
-73 -71
-75 -71
-81 -71
-82 -71
-83 -71
-85 -71
-87 -71
-90 -71
-91 -71
-95 -71
-97 -71
-0 -72
-1 -72
-5 -72
-20 -72
-28 -72
-41 -72
-53 -72
-56 -72
-85 -72
-96 -72
-1 -73
-11 -73
-17 -73
-25 -73
-39 -73
-41 -73
-49 -73
-56 -73
-59 -73
-69 -73
-71 -73
-75 -73
-81 -73
-92 -73
-24 -74
-99 -74
-1 -75
-7 -75
-11 -75
-17 -75
-21 -75
-23 -75
-25 -75
-27 -75
-31 -75
-37 -75
-39 -75
-41 -75
-47 -75
-50 -75
-51 -75
-57 -75
-59 -75
-61 -75
-67 -75
-71 -75
-73 -75
-75 -75
-77 -75
-79 -75
-81 -75
-87 -75
-91 -75
-97 -75
-98 -75
-99 -75
-0 -76
-1 -76
-5 -76
-6 -76
-12 -76
-16 -76
-18 -76
-20 -76
-21 -76
-28 -76
-30 -76
-32 -76
-36 -76
-38 -76
-53 -76
-56 -76
-60 -76
-62 -76
-65 -76
-66 -76
-68 -76
-70 -76
-80 -76
-82 -76
-88 -76
-1 -77
-5 -77
-31 -77
-33 -77
-61 -77
-75 -77
-83 -77
-85 -77
-91 -77
-95 -77
-4 -78
-11 -78
-15 -78
-19 -78
-39 -78
-40 -78
-51 -78
-56 -78
-84 -78
-96 -78
-3 -79
-15 -79
-18 -79
-19 -79
-25 -79
-29 -79
-30 -79
-33 -79
-38 -79
-43 -79
-53 -79
-54 -79
-55 -79
-63 -79
-65 -79
-69 -79
-70 -79
-75 -79
-79 -79
-83 -79
-94 -79
-95 -79
-99 -79
-8 -80
-21 -80
-29 -80
-40 -80
-41 -80
-44 -80
-56 -80
-58 -80
-60 -80
-76 -80
-84 -80
-85 -80
-89 -80
-90 -80
-0 -81
-5 -81
-12 -81
-13 -81
-17 -81
-21 -81
-23 -81
-25 -81
-35 -81
-36 -81
-37 -81
-41 -81
-51 -81
-60 -81
-61 -81
-65 -81
-68 -81
-71 -81
-73 -81
-75 -81
-85 -81
-88 -81
-92 -81
-93 -81
-96 -81
-0 -82
-11 -82
-16 -82
-20 -82
-35 -82
-55 -82
-63 -82
-71 -82
-76 -82
-88 -82
-2 -83
-11 -83
-21 -83
-27 -83
-31 -83
-39 -83
-46 -83
-55 -83
-59 -83
-71 -83
-77 -83
-79 -83
-91 -83
-99 -83
-9 -84
-14 -84
-20 -84
-24 -84
-28 -84
-30 -84
-34 -84
-48 -84
-49 -84
-64 -84
-70 -84
-78 -84
-80 -84
-84 -84
-89 -84
-98 -84
-5 -85
-9 -85
-12 -85
-17 -85
-32 -85
-37 -85
-39 -85
-45 -85
-52 -85
-57 -85
-61 -85
-68 -85
-69 -85
-71 -85
-72 -85
-77 -85
-80 -85
-81 -85
-91 -85
-92 -85
-93 -85
-95 -85
-97 -85
-99 -85
-0 -86
-15 -86
-16 -86
-31 -86
-36 -86
-43 -86
-51 -86
-55 -86
-60 -86
-68 -86
-11 -87
-31 -87
-35 -87
-43 -87
-51 -87
-55 -87
-71 -87
-75 -87
-95 -87
-9 -88
-16 -88
-20 -88
-21 -88
-24 -88
-29 -88
-32 -88
-44 -88
-45 -88
-66 -88
-76 -88
-81 -88
-82 -88
-5 -89
-8 -89
-9 -89
-28 -89
-33 -89
-39 -89
-40 -89
-49 -89
-53 -89
-59 -89
-64 -89
-65 -89
-80 -89
-84 -89
-89 -89
-99 -89
-4 -90
-36 -90
-39 -90
-44 -90
-51 -90
-55 -90
-56 -90
-71 -90
-80 -90
-99 -90
-6 -91
-7 -91
-11 -91
-13 -91
-15 -91
-18 -91
-21 -91
-22 -91
-23 -91
-25 -91
-27 -91
-30 -91
-31 -91
-33 -91
-35 -91
-42 -91
-43 -91
-47 -91
-51 -91
-55 -91
-57 -91
-61 -91
-63 -91
-66 -91
-67 -91
-70 -91
-71 -91
-75 -91
-77 -91
-83 -91
-85 -91
-91 -91
-95 -91
-98 -91
-0 -92
-5 -92
-20 -92
-36 -92
-41 -92
-48 -92
-73 -92
-81 -92
-85 -92
-96 -92
-11 -93
-12 -93
-19 -93
-29 -93
-35 -93
-36 -93
-37 -93
-39 -93
-41 -93
-49 -93
-51 -93
-61 -93
-81 -93
-85 -93
-4 -94
-19 -94
-24 -94
-44 -94
-79 -94
-99 -94
-7 -95
-10 -95
-11 -95
-13 -95
-15 -95
-17 -95
-19 -95
-27 -95
-35 -95
-37 -95
-38 -95
-47 -95
-51 -95
-57 -95
-59 -95
-63 -95
-67 -95
-71 -95
-77 -95
-79 -95
-85 -95
-87 -95
-91 -95
-97 -95
-99 -95
-0 -96
-5 -96
-6 -96
-8 -96
-10 -96
-16 -96
-20 -96
-22 -96
-28 -96
-33 -96
-42 -96
-46 -96
-48 -96
-56 -96
-60 -96
-61 -96
-65 -96
-70 -96
-72 -96
-78 -96
-81 -96
-92 -96
-96 -96
-98 -96
-1 -97
-3 -97
-5 -97
-31 -97
-41 -97
-53 -97
-71 -97
-75 -97
-85 -97
-95 -97
-0 -98
-19 -98
-36 -98
-51 -98
-64 -98
-75 -98
-84 -98
-91 -98
-96 -98
-99 -98
-9 -99
-13 -99
-14 -99
-15 -99
-18 -99
-19 -99
-23 -99
-29 -99
-33 -99
-34 -99
-35 -99
-39 -99
-43 -99
-45 -99
-49 -99
-50 -99
-54 -99
-59 -99
-63 -99
-69 -99
-74 -99
-75 -99
-79 -99
-83 -99
-85 -99
-89 -99
-90 -99
-94 -99
-95 -99
-98 -99
-99 -99
-DEAL::OK
+++ /dev/null
-
-DEAL::0 xxx x x x x x x xx x x x x xxx x x x x x x x xx x x x x
-DEAL::1 xx x x x x x x x xx x x xx x x xx xxx x
-DEAL::2 x x x x x x x xx x
-DEAL::3 x x x x x x x x x x x x x x
-DEAL::4 x x x x xx x x xx x x x x x x
-DEAL::5 x x x xx x x x xxx xxx xx xx xx x x x x xx x x x x xx
-DEAL::6 x x x x x x x x x x
-DEAL::7 x x x x x x x x x
-DEAL::8 x xx x x x x x x x x x x x
-DEAL::9 x xx x x x x x xx x xx xx x
-DEAL::10 x x xx x x x x xx
-DEAL::11 xxx xx xx x x x x x x x x x x x x x x x x xx x x x xx x x x x
-DEAL::12 x x xx x x x x x x
-DEAL::13 x x x x x x x x x x x x x x
-DEAL::14 x x x x x x
-DEAL::15 x x x x x x x xx x x x x xx xx x x x x
-DEAL::16 x x x x x x x x x x x x x x x x x x x x x x x
-DEAL::17 x x x x x x x x x x
-DEAL::18 x xx x x x x x x x
-DEAL::19 x x x x x x x x x x xx x x xx xx xxx xx
-DEAL::20 x x x x x x x x xxx x xxx x x x x x x x x x
-DEAL::21 x x x xx x xx x x xx x x x x xx xx x x x
-DEAL::22 x x x x x x xx x x
-DEAL::23 x x x x x x x x x x x x x x x
-DEAL::24 x x x x x x x x x x x x x x x x x x x
-DEAL::25 xx x x x x xx x x x x x
-DEAL::26 x x x x x x xx x x
-DEAL::27 x x x x x x x x x
-DEAL::28 x x x x x x x x x x x x x x
-DEAL::29 xx x xx x xx x xx xx x x x
-DEAL::30 x x x x x x x x x x
-DEAL::31 x x x xx x x x x x x x xxx xx xx x x xx x x x x x x xx x x
-DEAL::32 x x x x xx x x x x
-DEAL::33 x x x x x x x x x x x x x
-DEAL::34 x x x x x x
-DEAL::35 xx x x x xx xx x xx x xxx x x x x xx x x xx x x x x x
-DEAL::36 xx x x x x x x x x x x x x x x x x x x xx x
-DEAL::37 x x x x x x x x x x
-DEAL::38 x x x x x x x x x x
-DEAL::39 x x xx x x x xx x x x xx x x x x x xx x x
-DEAL::40 x xx xx x x x x x x x x x
-DEAL::41 x x xx xx x x x x x x x x x x xx x xx xx x
-DEAL::42 x x x x xx x x x x
-DEAL::43 x x x x x x x xx x xx x x
-DEAL::44 x x x xx x x x x x xx x x x x
-DEAL::45 x x x x x xxx x x x x x x
-DEAL::46 x x x xx x x x x x
-DEAL::47 x x x x x x x x x
-DEAL::48 xx x x x xx x x x x x x x
-DEAL::49 x x x xx x x x xx xx xx x x x x x
-DEAL::50 x x x x x x x x x x
-DEAL::51 xx x x x x x xx xx x x x x x x x xx x x x x x x x xx xx x x x
-DEAL::52 xx x x x x x x x x
-DEAL::53 x x x x x x x xx x x x x
-DEAL::54 x x x x x x
-DEAL::55 x xx x x x x xx x x x x x xx x xx x xxx x x xx xx xx
-DEAL::56 x x x x x x x x x xx x x x xx xx xx x x x x x
-DEAL::57 x x x x x x x x x x
-DEAL::58 x x x x x xx x x x
-DEAL::59 x x xx x x xx xx x x x x xx x x x x x x x
-DEAL::60 x x x x x x x x x xx x x x x xx x xx x x
-DEAL::61 x x x x xx x xx x x x xx xx x x x x x x x x x
-DEAL::62 x x x xx x x x x x
-DEAL::63 x x x x x x x x x x x x x x
-DEAL::64 x xx x x x x xxx x x x x x x
-DEAL::65 x x x x xxx x x x x x x x xx x x x x x x
-DEAL::66 x x xx x x x x x x
-DEAL::67 x x x x x x x x x
-DEAL::68 x x x x x x x x x x x xx
-DEAL::69 x xx xx xx xx x x x x x x x
-DEAL::70 x x x x x x x x x x
-DEAL::71 x x x x x x x x xx x x x x x x x x xx xx x x x xxx x x xx x x
-DEAL::72 xx x x x x x x x x
-DEAL::73 x x x x x x x x x x x x x x
-DEAL::74 x x
-DEAL::75 x x x x x x x x x x x x x xx x x x x x x x x x x x x xxx
-DEAL::76 xx xx x x x xx x x x x x x x x x xx x x x x x
-DEAL::77 x x x x x x x x x x
-DEAL::78 x x x x xx x x x x
-DEAL::79 x x xx x xx x x x xxx x x xx x x x xx x
-DEAL::80 x x x xx x x x x x xx xx
-DEAL::81 x x xx x x x x xxx x x xx x x x x x x x xx x
-DEAL::82 x x x x x x x x x x
-DEAL::83 x x x x x x x x x x x x x x
-DEAL::84 x x x x x x x xx x x x x x x x
-DEAL::85 x x x x x x x x x x x xx xx x xx xxx x x x
-DEAL::86 x xx x x x x x x x
-DEAL::87 x x x x x x x x x
-DEAL::88 x x xx x x x xx x x xx
-DEAL::89 x xx x x xx x x x xx x x x x
-DEAL::90 x x x x x xx x x x
-DEAL::91 xx x x x x xxx x x xx x x xx x x x x x x xx xx x x x x x x x
-DEAL::92 x x x x x x x x x x
-DEAL::93 xx x x xxx x x x x x x x
-DEAL::94 x x x x x x
-DEAL::95 x xx x x x x x x xx x x x x x x x x x x x x x x
-DEAL::96 x xx x x x x x x x x x x x xx x x x x x x x x
-DEAL::97 x x x x x x x x x x
-DEAL::98 x x x x x x x x x x
-DEAL::99 x xxx xx x x xxx x x x xx x x x x xx x x x xx xx xx
+++ /dev/null
-
-DEAL:: 39
-// check CompressedSparsityPattern::n_nonzero_elements. test n_rows() and
+// check DynamicSparsityPattern::n_nonzero_elements. test n_rows() and
// n_cols() in passing
#include "../tests.h"
#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <iomanip>
#include <fstream>
void test ()
{
// set up a sparsity pattern. since
- // CompressedSparsityPatterns are most
+ // DynamicSparsityPatterns are most
// often used for 3d, use a rather large
// number of entries per row
const unsigned int N = 1000;
- CompressedSparsityPattern csp (N,N);
+ DynamicSparsityPattern csp (N,N);
for (unsigned int i=0; i<N; ++i)
for (unsigned int j=0; j<40; ++j)
csp.add (i, (i+(i+1)*(j*j+i))%N);
-// check CompressedSparsityPattern::bandwidth
+// check DynamicSparsityPattern::bandwidth
#include "../tests.h"
#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <iomanip>
#include <fstream>
void test ()
{
// set up a sparsity pattern. since
- // CompressedSparsityPatterns are most
+ // DynamicSparsityPatterns are most
// often used for 3d, use a rather large
// number of entries per row
const unsigned int N = 1000;
- CompressedSparsityPattern csp (N,N);
+ DynamicSparsityPattern csp (N,N);
for (unsigned int i=0; i<N; ++i)
for (unsigned int j=0; j<40; ++j)
csp.add (i, (i+(i+1)*(j*j+i))%N);
-// check CompressedSparsityPattern::row_length
+// check DynamicSparsityPattern::row_length
#include "../tests.h"
#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <iomanip>
#include <fstream>
void test ()
{
// set up a sparsity pattern. since
- // CompressedSparsityPatterns are most
+ // DynamicSparsityPatterns are most
// often used for 3d, use a rather large
// number of entries per row
const unsigned int N = 1000;
- CompressedSparsityPattern csp (N,N);
+ DynamicSparsityPattern csp (N,N);
for (unsigned int i=0; i<N; ++i)
for (unsigned int j=0; j<40; ++j)
csp.add (i, (i+(i+1)*(j*j+i))%N);
-// check CompressedSparsityPattern::column_number. since we create quite some
+// check DynamicSparsityPattern::column_number. since we create quite some
// output here, choose smaller number of rows and entries than in the other
// tests
#include "../tests.h"
#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <iomanip>
#include <fstream>
void test ()
{
const unsigned int N = 100;
- CompressedSparsityPattern csp (N,N);
+ DynamicSparsityPattern csp (N,N);
for (unsigned int i=0; i<N; ++i)
for (unsigned int j=0; j<10; ++j)
csp.add (i, (i+(i+1)*(j*j+i))%N);
-// check CompressedSparsityPattern::symmetrize. since we create quite some
+// check DynamicSparsityPattern::symmetrize. since we create quite some
// output here, choose smaller number of rows and entries than in the other
// tests
#include "../tests.h"
#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <iomanip>
#include <fstream>
void test ()
{
const unsigned int N = 100;
- CompressedSparsityPattern csp (N,N);
+ DynamicSparsityPattern csp (N,N);
for (unsigned int i=0; i<N; ++i)
for (unsigned int j=0; j<10; ++j)
csp.add (i, (i+(i+1)*(j*j+i))%N);
-// check CompressedSparsityPattern::print_gnuplot. since we create quite some
+// check DynamicSparsityPattern::print_gnuplot. since we create quite some
// output here, choose smaller number of rows and entries than in the other
// tests
#include "../tests.h"
#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <iomanip>
#include <fstream>
void test ()
{
const unsigned int N = 100;
- CompressedSparsityPattern csp (N,N);
+ DynamicSparsityPattern csp (N,N);
for (unsigned int i=0; i<N; ++i)
for (unsigned int j=0; j<10; ++j)
csp.add (i, (i+(i+1)*(j*j+i))%N);
-// check CompressedSparsityPattern::exists. since we create quite some
+// check DynamicSparsityPattern::exists. since we create quite some
// output here, choose smaller number of rows and entries than in the other
// tests
#include "../tests.h"
#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <iomanip>
#include <fstream>
void test ()
{
const unsigned int N = 100;
- CompressedSparsityPattern csp (N,N);
+ DynamicSparsityPattern csp (N,N);
for (unsigned int i=0; i<N; ++i)
for (unsigned int j=0; j<10; ++j)
csp.add (i, (i+(i+1)*(j*j+i))%N);
-// check CompressedSparsityPattern::max_entries_per_row
+// check DynamicSparsityPattern::max_entries_per_row
#include "../tests.h"
#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <iomanip>
#include <fstream>
void test ()
{
// set up a sparsity pattern. since
- // CompressedSparsityPatterns are most
+ // DynamicSparsityPatterns are most
// often used for 3d, use a rather large
// number of entries per row
const unsigned int N = 1000;
- CompressedSparsityPattern csp (N,N);
+ DynamicSparsityPattern csp (N,N);
for (unsigned int i=0; i<N; ++i)
for (unsigned int j=0; j<40; ++j)
csp.add (i, (i+(i+1)*(j*j+i))%N);
-// check CompressedSparsityPattern::empty
+// check DynamicSparsityPattern::empty
#include "../tests.h"
#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <iomanip>
#include <fstream>
void test ()
{
const unsigned int N = 1000;
- CompressedSparsityPattern csp;
+ DynamicSparsityPattern csp;
AssertThrow (csp.empty() == true, ExcInternalError());
csp.reinit (N, N);
-// check SparsityPattern::copy_from(CompressedSparsityPattern)
+// check SparsityPattern::copy_from(DynamicSparsityPattern)
#include "../tests.h"
#include <deal.II/base/logstream.h>
#include <deal.II/lac/sparsity_pattern.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <iomanip>
#include <fstream>
void test ()
{
const unsigned int N = 100;
- CompressedSparsityPattern csp (N,N);
+ DynamicSparsityPattern csp (N,N);
for (unsigned int i=0; i<N; ++i)
for (unsigned int j=0; j<10; ++j)
csp.add (i, (i+(i+1)*(j*j+i))%N);
-// check SparsityPattern::copy_from(CompressedSetSparsityPattern)
+// check SparsityPattern::copy_from(DynamicSparsityPattern)
#include "../tests.h"
#include <deal.II/base/logstream.h>
#include <deal.II/lac/sparsity_pattern.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <iomanip>
#include <fstream>
void test ()
{
const unsigned int N = 100;
- CompressedSetSparsityPattern csp (N,N);
+ DynamicSparsityPattern csp (N,N);
for (unsigned int i=0; i<N; ++i)
for (unsigned int j=0; j<10; ++j)
csp.add (i, (i+(i+1)*(j*j+i))%N);
#include <deal.II/lac/vector.h>
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/precondition.h>
#include <deal.II/grid/tria.h>
constraints.close ();
{
- CompressedSimpleSparsityPattern csp (dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp, constraints, false);
sparsity_pattern.copy_from(csp);
}
constraints_trace.close ();
{
- CompressedSimpleSparsityPattern csp (dof_handler_trace.n_dofs());
+ DynamicSparsityPattern csp (dof_handler_trace.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler_trace, csp, constraints_trace, false);
sparsity_pattern_trace.copy_from(csp);
}
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <algorithm>
#include <iomanip>
i, -1);
mean_value_constraints.close ();
- CompressedSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp);
mean_value_constraints.condense (csp);
#include <deal.II/grid/grid_tools.h>
#include <deal.II/integrators/laplace.h>
#include <deal.II/lac/vector.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/precondition.h>
#include <deal.II/meshworker/dof_info.h>
#include <deal.II/base/work_stream.h>
#include <deal.II/base/tensor_function.h>
#include <deal.II/lac/constraint_matrix.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/sparse_matrix.h>
#include <deal.II/lac/solver_bicgstab.h>
#include <deal.II/lac/precondition.h>
constraints.close ();
{
- CompressedSimpleSparsityPattern csp (dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp,
constraints, false);
sparsity_pattern.copy_from(csp);
#include <deal.II/base/work_stream.h>
#include <deal.II/base/tensor_function.h>
#include <deal.II/lac/constraint_matrix.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/sparse_matrix.h>
#include <deal.II/lac/solver_bicgstab.h>
#include <deal.II/lac/precondition.h>
constraints.close ();
{
- CompressedSimpleSparsityPattern csp (dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp,
constraints, false);
sparsity_pattern.copy_from(csp);
// printing all nonzero entries
#include "../tests.h"
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
// then set up a sparsity pattern and a
// matrix on top of it
- CompressedSparsityPattern sparsity (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern sparsity (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, sparsity);
constraints.condense (sparsity);
-// simply check what happens when condensing compressed set sparsity patterns by
+// simply check what happens when condensing DynamicSparsityPattern by
// printing all nonzero entries
#include "../tests.h"
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/grid/tria_iterator.h>
// then set up a sparsity pattern and a
// matrix on top of it
- CompressedSetSparsityPattern sparsity (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern sparsity (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, sparsity);
constraints.condense (sparsity);
// algorithm.
#include "../tests.h"
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/sparsity_pattern.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
// then set up a sparsity pattern and a
// matrix on top of it
- CompressedSparsityPattern sparsity (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern sparsity (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, sparsity);
constraints.condense (sparsity);
-// simply check what happens when condensing compressed set sparsity
-// patterns. This test was written when I changed a few things in the
-// algorithm.
+// simply check what happens when condensing DynamicSparsityPattern. This test
+// was written when I changed a few things in the algorithm.
#include "../tests.h"
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/sparsity_pattern.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_accessor.h>
// then set up a sparsity pattern and a
// matrix on top of it
- CompressedSetSparsityPattern sparsity (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern sparsity (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, sparsity);
constraints.condense (sparsity);
// algorithm.
#include "../tests.h"
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/block_sparsity_pattern.h>
#include <deal.II/lac/sparsity_pattern.h>
#include <deal.II/grid/tria.h>
block_sizes[0] = dof_handler.n_dofs()/3;
block_sizes[1] = dof_handler.n_dofs() - block_sizes[0];
- BlockCompressedSparsityPattern sparsity(2,2);
+ BlockDynamicSparsityPattern sparsity(2,2);
for (unsigned int i=0; i<2; ++i)
for (unsigned int j=0; j<2; ++j)
sparsity.block(i,j).reinit (block_sizes[i], block_sizes[j]);
-// simply check what happens when condensing compressed set block sparsity
-// patterns. This test was written when I changed a few things in the
-// algorithm.
+// simply check what happens when condensing BlockDyanmicSparsityPattern. This
+// test was written when I changed a few things in the algorithm.
#include "../tests.h"
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
#include <deal.II/lac/block_sparsity_pattern.h>
#include <deal.II/lac/sparsity_pattern.h>
#include <deal.II/grid/tria.h>
block_sizes[0] = dof_handler.n_dofs()/3;
block_sizes[1] = dof_handler.n_dofs() - block_sizes[0];
- BlockCompressedSetSparsityPattern sparsity(2,2);
+ BlockDynamicSparsityPattern sparsity(2,2);
for (unsigned int i=0; i<2; ++i)
for (unsigned int j=0; j<2; ++j)
sparsity.block(i,j).reinit (block_sizes[i], block_sizes[j]);
#include "../tests.h"
#include "dof_tools_common.h"
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
// check
// DoFTools::
// make_sparsity_pattern (const DoFHandler<dim> &,
-// CompressedSparsityPattern &);
+// DynamicSparsityPattern &);
std::string output_file_name = "output";
check_this (const DoFHandler<dim> &dof_handler)
{
// create sparsity pattern
- CompressedSparsityPattern sp (dof_handler.n_dofs());
+ DynamicSparsityPattern sp (dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, sp);
sp.compress ();
// check
// DoFTools::
// make_sparsity_pattern (const DoFHandler<dim> &,
-// BlockCompressedSparsityPattern &);
+// BlockDynamicSparsityPattern &);
std::string output_file_name = "output";
// create sparsity pattern
const unsigned int n_components = dof_handler.get_fe().n_components();
- BlockCompressedSparsityPattern sp (n_components,
- n_components);
+ BlockDynamicSparsityPattern sp (n_components,
+ n_components);
std::vector<types::global_dof_index> dofs_per_component(n_components);
DoFTools::count_dofs_per_component (dof_handler,
dofs_per_component);
for (unsigned int r=0; r<n_components; ++r)
for (unsigned int c=0; c<n_components; ++c)
{
- const CompressedSparsityPattern &x = sp.block(r,c);
+ const DynamicSparsityPattern &x = sp.block(r,c);
deallog << x.bandwidth () << std::endl
<< x.max_entries_per_row () << std::endl
<< x.n_nonzero_elements () << std::endl;
#include "../tests.h"
#include "dof_tools_common.h"
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
// check
// DoFTools::
// make_sparsity_pattern (const DoFHandler<dim> &,
// Table<2,Coupling> &,
-// CompressedSparsityPattern &);
+// DynamicSparsityPattern &);
std::string output_file_name = "output";
mask[i][i] = mask[i][n_components-i-1] = DoFTools::always;
// create sparsity pattern
- CompressedSparsityPattern sp (dof_handler.n_dofs());
+ DynamicSparsityPattern sp (dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, mask, sp);
sp.compress ();
// DoFTools::
// make_sparsity_pattern (const DoFHandler<dim> &,
// std::vector<std::vector<bool> > &,
-// BlockCompressedSparsityPattern &);
+// BlockDynamicSparsityPattern &);
std::string output_file_name = "output";
return;
// create sparsity pattern
- BlockCompressedSparsityPattern sp (n_components,
- n_components);
+ BlockDynamicSparsityPattern sp (n_components,
+ n_components);
std::vector<types::global_dof_index> dofs_per_component(n_components);
DoFTools::count_dofs_per_component (dof_handler,
dofs_per_component);
for (unsigned int r=0; r<n_components; ++r)
for (unsigned int c=0; c<n_components; ++c)
{
- const CompressedSparsityPattern &x = sp.block(r,c);
+ const DynamicSparsityPattern &x = sp.block(r,c);
deallog << x.bandwidth () << std::endl
<< x.max_entries_per_row () << std::endl
<< x.n_nonzero_elements () << std::endl;
#include "../tests.h"
#include "dof_tools_common.h"
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
// check
// DoFTools::
// make_boundary_sparsity_pattern (const DoFHandler<dim> &,
// const std::vector<unsigned int> &
-// CompressedSparsityPattern &);
+// DynamicSparsityPattern &);
std::string output_file_name = "output";
DoFTools::map_dof_to_boundary_indices (dof_handler, map);
// create sparsity pattern
- CompressedSparsityPattern sp (dof_handler.n_boundary_dofs());
+ DynamicSparsityPattern sp (dof_handler.n_boundary_dofs());
DoFTools::make_boundary_sparsity_pattern (dof_handler, map, sp);
sp.compress ();
// DoFTools::
// make_boundary_sparsity_pattern (const DoFHandler<dim> &,
// const std::vector<unsigned int> &
-// BlockCompressedSparsityPattern &);
+// BlockDynamicSparsityPattern &);
std::string output_file_name = "output";
const unsigned int n_blocks = std::min (
static_cast<types::global_dof_index>(dof_handler.get_fe().n_components()),
dof_handler.n_boundary_dofs());
- BlockCompressedSparsityPattern sp (n_blocks,
- n_blocks);
+ BlockDynamicSparsityPattern sp (n_blocks,
+ n_blocks);
// split dofs almost arbitrarily to
// blocks
std::vector<types::global_dof_index> dofs_per_block(n_blocks);
for (unsigned int r=0; r<n_blocks; ++r)
for (unsigned int c=0; c<n_blocks; ++c)
{
- const CompressedSparsityPattern &x = sp.block(r,c);
+ const DynamicSparsityPattern &x = sp.block(r,c);
deallog << x.bandwidth () << std::endl
<< x.max_entries_per_row () << std::endl
<< x.n_nonzero_elements () << std::endl;
#include "../tests.h"
#include "dof_tools_common.h"
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
// check
// DoFTools::
// make_boundary_sparsity_pattern (const DoFHandler<dim> &,
// const typename FunctionMap<dim>::type &
// const std::vector<unsigned int> &
-// CompressedSparsityPattern &);
+// DynamicSparsityPattern &);
std::string output_file_name = "output";
// create sparsity pattern
typename FunctionMap<dim>::type boundary_ids;
boundary_ids[0] = 0;
- CompressedSparsityPattern sp (dof_handler.n_boundary_dofs(boundary_ids));
+ DynamicSparsityPattern sp (dof_handler.n_boundary_dofs(boundary_ids));
DoFTools::make_boundary_sparsity_pattern (dof_handler, boundary_ids,
map, sp);
sp.compress ();
// make_boundary_sparsity_pattern (const DoFHandler<dim> &,
// const typename FunctionMap<dim>::type &
// const std::vector<unsigned int> &
-// BlockCompressedSparsityPattern &);
+// BlockDynamicSparsityPattern &);
std::string output_file_name = "output";
const unsigned int n_blocks = std::min (
static_cast<types::global_dof_index>(dof_handler.get_fe().n_components()),
n_boundary_dofs);
- BlockCompressedSparsityPattern sp (n_blocks,
- n_blocks);
+ BlockDynamicSparsityPattern sp (n_blocks,
+ n_blocks);
// split dofs almost arbitrarily to
// blocks
std::vector<types::global_dof_index> dofs_per_block(n_blocks);
for (unsigned int r=0; r<n_blocks; ++r)
for (unsigned int c=0; c<n_blocks; ++c)
{
- const CompressedSparsityPattern &x = sp.block(r,c);
+ const DynamicSparsityPattern &x = sp.block(r,c);
deallog << x.bandwidth () << std::endl
<< x.max_entries_per_row () << std::endl
<< x.n_nonzero_elements () << std::endl;
#include "../tests.h"
#include "dof_tools_common.h"
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
// check
// DoFTools::
// make_flux_sparsity_pattern (const DoFHandler<dim> &,
-// CompressedSparsityPattern &);
+// DynamicSparsityPattern &);
std::string output_file_name = "output";
check_this (const DoFHandler<dim> &dof_handler)
{
// create sparsity pattern
- CompressedSparsityPattern sp (dof_handler.n_dofs());
+ DynamicSparsityPattern sp (dof_handler.n_dofs());
DoFTools::make_flux_sparsity_pattern (dof_handler, sp);
sp.compress ();
// check
// DoFTools::
// make_flux_sparsity_pattern (const DoFHandler<dim> &,
-// BlockCompressedSparsityPattern &);
+// BlockDynamicSparsityPattern &);
std::string output_file_name = "output";
// create sparsity pattern
const unsigned int n_components = dof_handler.get_fe().n_components();
- BlockCompressedSparsityPattern sp (n_components,
- n_components);
+ BlockDynamicSparsityPattern sp (n_components,
+ n_components);
std::vector<types::global_dof_index> dofs_per_component(n_components);
DoFTools::count_dofs_per_component (dof_handler,
dofs_per_component);
for (unsigned int r=0; r<n_components; ++r)
for (unsigned int c=0; c<n_components; ++c)
{
- const CompressedSparsityPattern &x = sp.block(r,c);
+ const DynamicSparsityPattern &x = sp.block(r,c);
deallog << x.bandwidth () << std::endl
<< x.max_entries_per_row () << std::endl
<< x.n_nonzero_elements () << std::endl;
#include "../tests.h"
#include "dof_tools_common.h"
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
// check
// DoFTools::
// make_flux_sparsity_pattern (const DoFHandler<dim> &,
-// CompressedSparsityPattern &);
+// DynamicSparsityPattern &);
std::string output_file_name = "output";
mask_int, mask_ext);
// create sparsity pattern
- CompressedSparsityPattern sp (dof_handler.n_dofs());
+ DynamicSparsityPattern sp (dof_handler.n_dofs());
DoFTools::make_flux_sparsity_pattern (dof_handler, sp,
mask_int, mask_ext);
sp.compress ();
// check
// DoFTools::
// make_flux_sparsity_pattern (const DoFHandler<dim> &,
-// BlockCompressedSparsityPattern &);
+// BlockDynamicSparsityPattern &);
std::string output_file_name = "output";
// create sparsity pattern
const unsigned int n_components = dof_handler.get_fe().n_components();
- BlockCompressedSparsityPattern sp (n_components,
- n_components);
+ BlockDynamicSparsityPattern sp (n_components,
+ n_components);
std::vector<types::global_dof_index> dofs_per_component(n_components);
DoFTools::count_dofs_per_component (dof_handler,
dofs_per_component);
for (unsigned int r=0; r<n_components; ++r)
for (unsigned int c=0; c<n_components; ++c)
{
- const CompressedSparsityPattern &x = sp.block(r,c);
+ const DynamicSparsityPattern &x = sp.block(r,c);
deallog << x.bandwidth () << std::endl
<< x.max_entries_per_row () << std::endl
<< x.n_nonzero_elements () << std::endl;
#include <deal.II/lac/vector.h>
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/precondition.h>
#include <deal.II/grid/tria.h>
constraints.close ();
- CompressedSparsityPattern c_sparsity(dof_handler.n_dofs());
+ DynamicSparsityPattern c_sparsity(dof_handler.n_dofs());
DoFTools::make_sparsity_pattern(dof_handler,
c_sparsity,
constraints,
/* Author: Wolfgang Bangerth, University of Heidelberg, 2001 */
// check that the direct generation of the sparsity pattern and that
-// via the CompressedSparsityPattern result in the same
+// via the DynamicSparsityPattern result in the same
#include "../tests.h"
#include <deal.II/base/logstream.h>
#include <deal.II/lac/sparsity_pattern.h>
#include <deal.II/lac/block_sparsity_pattern.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/grid/tria_accessor.h>
sparsity_1);
sparsity_1.compress ();
- // second way: via a CompressedSparsityPattern
+ // second way: via a DynamicSparsityPattern
SparsityPattern sparsity_2;
- CompressedSparsityPattern csp(dof.n_boundary_dofs());
+ DynamicSparsityPattern csp(dof.n_boundary_dofs());
DoFTools::make_boundary_sparsity_pattern (dof,
dof_to_boundary_mapping,
csp);
sparsity_1.compress ();
// second way: via
- // CompressedSparsityPattern
+ // DynamicSparsityPattern
SparsityPattern sparsity_2;
- CompressedSparsityPattern csp_2 (dof.n_dofs());
+ DynamicSparsityPattern csp_2 (dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, mask, csp_2);
constraints.condense (csp_2);
sparsity_2.copy_from (csp_2);
sparsity_3.compress ();
BlockSparsityPattern sparsity_4;
- BlockCompressedSparsityPattern csp_4(2,2);
+ BlockDynamicSparsityPattern csp_4(2,2);
csp_4.block(0,0).reinit (n1,n1);
csp_4.block(1,0).reinit (n2,n1);
csp_4.block(0,1).reinit (n1,n2);
#include <deal.II/base/logstream.h>
#include <deal.II/lac/sparsity_pattern.h>
#include <deal.II/lac/block_sparsity_pattern.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/grid/tria_accessor.h>
sparsity_1);
sparsity_1.compress ();
- // second way: via a CompressedSparsityPattern
+ // second way: via a DynamicSparsityPattern
SparsityPattern sparsity_2;
- CompressedSparsityPattern csp(dof.n_boundary_dofs());
+ DynamicSparsityPattern csp(dof.n_boundary_dofs());
DoFTools::make_boundary_sparsity_pattern (dof,
dof_to_boundary_mapping,
csp);
sparsity_1.compress ();
// second way: via
- // CompressedSparsityPattern
+ // DynamicSparsityPattern
SparsityPattern sparsity_2;
- CompressedSparsityPattern csp_2 (dof.n_dofs());
+ DynamicSparsityPattern csp_2 (dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, mask, csp_2);
constraints.condense (csp_2);
sparsity_2.copy_from (csp_2);
sparsity_3.compress ();
BlockSparsityPattern sparsity_4;
- BlockCompressedSparsityPattern csp_4(2,2);
+ BlockDynamicSparsityPattern csp_4(2,2);
csp_4.block(0,0).reinit (n1,n1);
csp_4.block(1,0).reinit (n2,n1);
csp_4.block(0,1).reinit (n1,n2);
#include <deal.II/base/logstream.h>
#include <deal.II/lac/sparsity_pattern.h>
#include <deal.II/lac/block_sparsity_pattern.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/grid/tria_accessor.h>
sparsity_1);
sparsity_1.compress ();
- // second way: via a CompressedSetSparsityPattern
+ // second way: via a DynamicSparsityPattern
SparsityPattern sparsity_2;
- CompressedSetSparsityPattern csp(dof.n_boundary_dofs());
+ DynamicSparsityPattern csp(dof.n_boundary_dofs());
DoFTools::make_boundary_sparsity_pattern (dof,
dof_to_boundary_mapping,
csp);
sparsity_1.compress ();
// second way: via
- // CompressedSetSparsityPattern
+ // DynamicSparsityPattern
SparsityPattern sparsity_2;
- CompressedSetSparsityPattern csp_2 (dof.n_dofs());
+ DynamicSparsityPattern csp_2 (dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, mask, csp_2);
constraints.condense (csp_2);
sparsity_2.copy_from (csp_2);
sparsity_3.compress ();
BlockSparsityPattern sparsity_4;
- BlockCompressedSetSparsityPattern csp_4(2,2);
+ BlockDynamicSparsityPattern csp_4(2,2);
csp_4.block(0,0).reinit (n1,n1);
csp_4.block(1,0).reinit (n2,n1);
csp_4.block(0,1).reinit (n1,n2);
#include <deal.II/base/logstream.h>
#include <deal.II/lac/sparsity_pattern.h>
#include <deal.II/lac/block_sparsity_pattern.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/base/logstream.h>
#include <deal.II/lac/sparsity_pattern.h>
#include <deal.II/lac/block_sparsity_pattern.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/base/logstream.h>
#include <deal.II/lac/sparsity_pattern.h>
#include <deal.II/lac/block_sparsity_pattern.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/grid/tria_accessor.h>
#include <deal.II/base/logstream.h>
#include <deal.II/lac/sparsity_pattern.h>
#include <deal.II/lac/block_sparsity_pattern.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/grid/tria_accessor.h>
// second way: via direct elimination of
// constraints
SparsityPattern sparsity_2;
- CompressedSparsityPattern csp_2 (dof.n_dofs());
+ DynamicSparsityPattern csp_2 (dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, csp_2, constraints);
sparsity_2.copy_from (csp_2);
sparsity_3.compress ();
BlockSparsityPattern sparsity_4;
- BlockCompressedSparsityPattern csp_4(2,2);
+ BlockDynamicSparsityPattern csp_4(2,2);
csp_4.block(0,0).reinit (n1,n1);
csp_4.block(1,0).reinit (n2,n1);
csp_4.block(0,1).reinit (n1,n2);
#include <deal.II/base/logstream.h>
#include <deal.II/lac/sparsity_pattern.h>
#include <deal.II/lac/block_sparsity_pattern.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/grid/tria_accessor.h>
// second way: via direct elimination of
// constraints
SparsityPattern sparsity_2;
- CompressedSetSparsityPattern csp_2 (dof.n_dofs());
+ DynamicSparsityPattern csp_2 (dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, csp_2, constraints);
sparsity_2.copy_from (csp_2);
sparsity_3.compress ();
BlockSparsityPattern sparsity_4;
- BlockCompressedSetSparsityPattern csp_4(2,2);
+ BlockDynamicSparsityPattern csp_4(2,2);
csp_4.block(0,0).reinit (n1,n1);
csp_4.block(1,0).reinit (n2,n1);
csp_4.block(0,1).reinit (n1,n2);
/* Author: Wolfgang Bangerth, University of Heidelberg, 2001 */
// check that the direct generation of the sparsity pattern and that
-// via the CompressedSetSparsityPattern result in the same
+// via the DynamicSparsityPattern result in the same
#include "../tests.h"
#include <deal.II/base/logstream.h>
#include <deal.II/lac/sparsity_pattern.h>
#include <deal.II/lac/block_sparsity_pattern.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/grid/tria_accessor.h>
sparsity_1);
sparsity_1.compress ();
- // second way: via a CompressedSetSparsityPattern
+ // second way: via a DynamicSparsityPattern
SparsityPattern sparsity_2;
- CompressedSetSparsityPattern csp(dof.n_boundary_dofs());
+ DynamicSparsityPattern csp(dof.n_boundary_dofs());
DoFTools::make_boundary_sparsity_pattern (dof,
dof_to_boundary_mapping,
csp);
constraints.condense (sparsity_1);
sparsity_1.compress ();
- // second way: via
- // CompressedSetSparsityPattern
+ // second way: via Dynamic SparsityPattern
SparsityPattern sparsity_2;
- CompressedSetSparsityPattern csp_2 (dof.n_dofs());
+ DynamicSparsityPattern csp_2 (dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, mask, csp_2);
constraints.condense (csp_2);
sparsity_2.copy_from (csp_2);
sparsity_3.compress ();
BlockSparsityPattern sparsity_4;
- BlockCompressedSetSparsityPattern csp_4(2,2);
+ BlockDynamicSparsityPattern csp_4(2,2);
csp_4.block(0,0).reinit (n1,n1);
csp_4.block(1,0).reinit (n2,n1);
csp_4.block(0,1).reinit (n1,n2);
#include <deal.II/lac/vector.h>
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/precondition.h>
#include <deal.II/grid/tria.h>
}
else
{
- CompressedSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp);
condense.reset();
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
#include <deal.II/lac/sparse_direct.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/precondition.h>
#include <deal.II/grid/tria.h>
VectorTools::project_boundary_values_curl_conforming(dof_handler, 0, ExactSolution<dim>(), 0, constraints);
constraints.close ();
- CompressedSparsityPattern c_sparsity(dof_handler.n_dofs());
+ DynamicSparsityPattern c_sparsity(dof_handler.n_dofs());
DoFTools::make_sparsity_pattern(dof_handler,
c_sparsity,
constraints,false);
#include <deal.II/lac/vector.h>
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/precondition.h>
<< dof_handler.n_dofs()
<< std::endl;
- CompressedSparsityPattern c_sparsity(dof_handler.n_dofs());
+ DynamicSparsityPattern c_sparsity(dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, c_sparsity);
sparsity_pattern.copy_from(c_sparsity);
<< std::endl;
{
- BlockCompressedSimpleSparsityPattern csp (2,2);
+ BlockDynamicSparsityPattern csp (2,2);
csp.block(0,0).reinit (n_u, n_u);
csp.block(1,0).reinit (n_p, n_u);
// compressed block sparsity
// pattern for efficiency
{
- BlockCompressedSimpleSparsityPattern csp(2, 2);
+ BlockDynamicSparsityPattern csp(2, 2);
csp.block(0, 0).reinit(n_stress_dof, n_stress_dof);
csp.block(1, 0).reinit(n_gamma_dof, n_stress_dof);
// compressed block sparsity
// pattern for efficiency
{
- BlockCompressedSimpleSparsityPattern csp(2, 2);
+ BlockDynamicSparsityPattern csp(2, 2);
csp.block(0, 0).reinit(n_stress_dof, n_stress_dof);
csp.block(1, 0).reinit(n_gamma_dof, n_stress_dof);
<< std::endl;
{
- BlockCompressedSimpleSparsityPattern csp(2, 2);
+ BlockDynamicSparsityPattern csp(2, 2);
csp.block(0, 0).reinit(n_stress_dof, n_stress_dof);
csp.block(1, 0).reinit(n_gamma_dof, n_stress_dof);
// following step-22 use of simple compressed block sparsity pattern for efficiency
{
- BlockCompressedSimpleSparsityPattern csp(2, 2);
+ BlockDynamicSparsityPattern csp(2, 2);
csp.block(0, 0).reinit(n_stress_dof, n_stress_dof);
csp.block(1, 0).reinit(n_gamma_dof, n_stress_dof);
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
#include <deal.II/lac/sparse_direct.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/constraint_matrix.h>
#include <deal.II/grid/tria.h>
constraints.close ();
- CompressedSparsityPattern c_sparsity(dof_handler.n_dofs());
+ DynamicSparsityPattern c_sparsity(dof_handler.n_dofs());
DoFTools::make_sparsity_pattern(dof_handler,
c_sparsity,
constraints,false);
partitioning.push_back(block2);
//LA::MPI::CompressedBlockSparsityPattern sp(partitioning);
- BlockCompressedSimpleSparsityPattern sp(partitioning);
+ BlockDynamicSparsityPattern sp(partitioning);
for (unsigned int i=0; i<15; ++i)
{
sp.add(i,i);
cm.close();
- BlockCompressedSimpleSparsityPattern sp(stokes_relevant_partitioning);
+ BlockDynamicSparsityPattern sp(stokes_relevant_partitioning);
Table<2,DoFTools::Coupling> coupling (1+1, 1+1);
coupling[0][0] = DoFTools::always;
ConstraintMatrix constraints(locally_relevant_dofs);
constraints.close();
- BlockCompressedSimpleSparsityPattern bcsp (locally_relevant_partitioning);
+ BlockDynamicSparsityPattern bcsp (locally_relevant_partitioning);
DoFTools::make_sparsity_pattern (dof_handler, bcsp, constraints, false);
SparsityTools::distribute_sparsity_pattern (bcsp, dof_handler.locally_owned_dofs_per_processor (), MPI_COMM_WORLD, locally_relevant_dofs);
IndexSet local_relevant= local_active;
local_relevant.add_range(0,1);
- CompressedSimpleSparsityPattern csp (local_relevant);
+ DynamicSparsityPattern csp (local_relevant);
for (unsigned int i=0; i<2*numproc; ++i)
if (local_relevant.is_element(i))
local_relevant.add_range(5,10);
local_relevant.add_range(0,1);
- CompressedSimpleSparsityPattern csp (local_relevant);
+ DynamicSparsityPattern csp (local_relevant);
for (unsigned int i=0; i<10; ++i)
if (local_relevant.is_element(i))
DoFTools::extract_locally_relevant_dofs (dof_handler, relevant);
// this causes a crash in PETSc, but is ignored in Trilinos:
- //CompressedSimpleSparsityPattern sp (owned);
- CompressedSimpleSparsityPattern sp (relevant);
+ //DynamicSparsityPattern sp (owned);
+ DynamicSparsityPattern sp (relevant);
typename LA::MPI::SparseMatrix matrix;
DoFTools::make_sparsity_pattern (dof_handler, sp,
cm, false,
IndexSet relevant;
DoFTools::extract_locally_relevant_dofs (dof_handler, relevant);
- CompressedSimpleSparsityPattern sp (relevant);
+ DynamicSparsityPattern sp (relevant);
typename LA::MPI::SparseMatrix matrix;
DoFTools::make_sparsity_pattern (dof_handler, sp,
cm, false,
IndexSet local_relevant= local_active;
local_relevant.add_range(0,1);
- CompressedSimpleSparsityPattern csp (local_relevant);
+ DynamicSparsityPattern csp (local_relevant);
for (unsigned int i=0; i<2*numproc; ++i)
if (local_relevant.is_element(i))
IndexSet local_relevant= local_active;
local_relevant.add_range(0,1);
- CompressedSimpleSparsityPattern csp (local_relevant);
+ DynamicSparsityPattern csp (local_relevant);
for (unsigned int i=0; i<2*numproc; ++i)
if (local_relevant.is_element(i))
#include <deal.II/lac/vector.h>
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/precondition.h>
#include <deal.II/grid/tria.h>
}
else
{
- CompressedSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp);
condense.reset();
// a modified version of step-27 that crashes because of circular constraints.
-// like crash_17, but use a Compressed*Set*SparsityPattern instead to test
+// like crash_17, but use a DynamicSparsityPattern instead to test
// that class some more
char logname[] = "output";
#include <deal.II/lac/vector.h>
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/precondition.h>
#include <deal.II/grid/tria.h>
}
else
{
- CompressedSetSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp);
condense.reset();
#include <deal.II/lac/vector.h>
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/precondition.h>
#include <deal.II/grid/tria.h>
}
else
{
- CompressedSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp);
condense.reset();
// we have dofs that are constrained against itself, and we don't
// currently detect this...
-// like crash_18, but use a Compressed*Set*SparsityPattern instead to test
+// like crash_18, but use a DynamicSparsityPattern instead to test
// that class some more
char logname[] = "output";
#include <deal.II/lac/vector.h>
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/precondition.h>
#include <deal.II/grid/tria.h>
}
else
{
- CompressedSetSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp);
condense.reset();
#include <deal.II/dofs/dof_accessor.h>
#include <deal.II/dofs/dof_tools.h>
#include <deal.II/fe/fe_dgq.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/hp/dof_handler.h>
#include <deal.II/hp/fe_values.h>
constraints.close ();
- CompressedSetSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_flux_sparsity_pattern (dof_handler, csp, constraints, false);
sparsity_pattern.copy_from (csp);
system_matrix.reinit (sparsity_pattern);
#include <deal.II/base/logstream.h>
#include <deal.II/base/function_lib.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/vector.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
Table<2,DoFTools::Coupling> mask (2, 2);
mask(0,0) = mask(1,1) = DoFTools::always;
mask(0,1) = mask(1,0) = DoFTools::none;
- CompressedSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, mask, csp, constraints);
sparsity.copy_from(csp);
}
#include <deal.II/base/logstream.h>
#include <deal.II/base/function_lib.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/vector.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
Table<2,DoFTools::Coupling> mask (2, 2);
mask(0,0) = mask(1,1) = DoFTools::always;
mask(0,1) = mask(1,0) = DoFTools::none;
- CompressedSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, mask, csp, constraints);
sparsity.copy_from(csp);
}
#include <deal.II/base/logstream.h>
#include <deal.II/base/function_lib.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/vector.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
Table<2,DoFTools::Coupling> mask (2, 2);
mask(0,0) = mask(1,1) = DoFTools::always;
mask(0,1) = mask(1,0) = DoFTools::none;
- CompressedSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, mask, csp, constraints);
sparsity.copy_from(csp);
}
#include <deal.II/base/logstream.h>
#include <deal.II/base/function_lib.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/vector.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
Table<2,DoFTools::Coupling> mask (2, 2);
mask(0,0) = mask(1,1) = DoFTools::always;
mask(0,1) = mask(1,0) = DoFTools::none;
- CompressedSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, mask, csp, constraints);
sparsity.copy_from(csp);
}
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/sparse_direct.h> //direct solver
#include <deal.II/lac/sparse_matrix.h> //definition of the sparse matrix
-#include <deal.II/lac/compressed_sparsity_pattern.h> //for the intermediate sparsity pattern structure
+#include <deal.II/lac/dynamic_sparsity_pattern.h> //for the intermediate sparsity pattern structure
#include <deal.II/lac/solver_cg.h> //CG solver
#include <deal.II/lac/precondition.h> //and a preconditioner
#include <deal.II/lac/constraint_matrix.h> //conform hanging nodes DoF to certain constrains to make the solution continuous
//(4) create block sparsity pattern (define which elements in sparse matrix are non-zero; prescribe coupling between blocks)
// following step-22 use of simple compressed block sparsity pattern for efficiency
- BlockCompressedSparsityPattern compressed_sparsity_pattern(n_blocks,
- n_blocks);
+ BlockDynamicSparsityPattern dynamic_sparsity_pattern(n_blocks,
+ n_blocks);
- compressed_sparsity_pattern.block(u_block ,u_block ).reinit(dofs_per_block[u_block] ,dofs_per_block[u_block]);
- compressed_sparsity_pattern.block(u_block ,lambda_block).reinit(dofs_per_block[u_block] ,dofs_per_block[lambda_block]);
- compressed_sparsity_pattern.block(lambda_block,u_block ).reinit(dofs_per_block[lambda_block],dofs_per_block[u_block]);
- compressed_sparsity_pattern.block(lambda_block,lambda_block).reinit(dofs_per_block[lambda_block],dofs_per_block[lambda_block]);
+ dynamic_sparsity_pattern.block(u_block ,u_block ).reinit(dofs_per_block[u_block] ,dofs_per_block[u_block]);
+ dynamic_sparsity_pattern.block(u_block ,lambda_block).reinit(dofs_per_block[u_block] ,dofs_per_block[lambda_block]);
+ dynamic_sparsity_pattern.block(lambda_block,u_block ).reinit(dofs_per_block[lambda_block],dofs_per_block[u_block]);
+ dynamic_sparsity_pattern.block(lambda_block,lambda_block).reinit(dofs_per_block[lambda_block],dofs_per_block[lambda_block]);
- compressed_sparsity_pattern.collect_sizes();
+ dynamic_sparsity_pattern.collect_sizes();
Table<2, DoFTools::Coupling> coupling(n_components, n_components);
for (unsigned int ii = 0; ii< n_components; ++ii)
coupling[ii][jj] = DoFTools::always;//full coupling (u,u), (u,lambda)
}
- hanging_node_constraints.condense (compressed_sparsity_pattern);
+ hanging_node_constraints.condense (dynamic_sparsity_pattern);
DoFTools::make_sparsity_pattern (dof_handler,
coupling,
- compressed_sparsity_pattern,
+ dynamic_sparsity_pattern,
hanging_node_constraints,
false);
- compressed_sparsity_pattern.print (deallog.get_file_stream());
+ dynamic_sparsity_pattern.print (deallog.get_file_stream());
hanging_node_constraints.print (deallog.get_file_stream());
}
#include <deal.II/fe/fe_tools.h>
#include <deal.II/grid/grid_generator.h>
#include <deal.II/lac/sparsity_tools.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/hp/fe_values.h>
#include <deal.II/lac/petsc_parallel_vector.h>
#include <deal.II/fe/fe_tools.h>
#include <deal.II/grid/grid_generator.h>
#include <deal.II/lac/sparsity_tools.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/hp/fe_values.h>
#include <deal.II/lac/petsc_parallel_vector.h>
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <algorithm>
#include <iostream>
i, -1);
mean_value_constraints.close ();
- CompressedSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp);
mean_value_constraints.condense (csp);
// a hp-ified version of step-11
-// like step-11, but use a Compressed*Set*SparsityPattern instead to test
+// like step-11, but use a DynamicSparsityPattern instead to test
// that class some more
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <algorithm>
#include <iostream>
i, -1);
mean_value_constraints.close ();
- CompressedSetSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp);
mean_value_constraints.condense (csp);
typename DoFHandler<dim>::face_iterator face = cell->face(1);
typename DoFHandler<dim>::active_cell_iterator neighbor = cell->neighbor(1);
- CompressedSparsityPattern csp(dof.n_dofs(),dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(),dof.n_dofs());
DoFTools::make_flux_sparsity_pattern(dof, csp);
SparsityPattern sparsity;
sparsity.copy_from(csp);
typename DoFHandler<dim>::face_iterator face = cell->face(1);
typename DoFHandler<dim>::active_cell_iterator neighbor = cell->neighbor(1);
- CompressedSparsityPattern csp(dof.n_dofs(),dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(),dof.n_dofs());
DoFTools::make_flux_sparsity_pattern(dof, csp);
TrilinosWrappers::SparsityPattern sparsity;
sparsity.copy_from(csp);
typename DoFHandler<dim>::face_iterator face = cell->face(1);
typename DoFHandler<dim>::active_cell_iterator neighbor = cell->neighbor(1);
- CompressedSparsityPattern csp(dof.n_dofs(),dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(),dof.n_dofs());
DoFTools::make_flux_sparsity_pattern(dof, csp);
SparsityPattern sparsity;
sparsity.copy_from(csp);
for (unsigned int level=0; level<tr.n_levels(); ++level)
{
- CompressedSparsityPattern csp(dof.n_dofs(level),dof.n_dofs(level));
+ DynamicSparsityPattern csp(dof.n_dofs(level),dof.n_dofs(level));
MGTools::make_flux_sparsity_pattern(dof, csp, level);
sparsity[level].copy_from(csp);
matrix[level].reinit(sparsity[level]);
#include <deal.II/lac/vector.h>
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/grid/tria.h>
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/meshworker/loop.h>
#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/sparsity_pattern.h>
#include <deal.II/lac/sparse_matrix.h>
#include <deal.II/grid/grid_generator.h>
for (unsigned int level=mg_sparsity.min_level();
level<=mg_sparsity.max_level(); ++level)
{
- CompressedSparsityPattern c_sparsity(mgdofs.n_dofs(level));
- CompressedSparsityPattern ci_sparsity;
+ DynamicSparsityPattern c_sparsity(mgdofs.n_dofs(level));
+ DynamicSparsityPattern ci_sparsity;
if (level>0)
ci_sparsity.reinit(mgdofs.n_dofs(level-1), mgdofs.n_dofs(level));
#include <deal.II/meshworker/loop.h>
#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/sparsity_pattern.h>
#include <deal.II/lac/sparse_matrix.h>
#include <deal.II/grid/grid_generator.h>
for (unsigned int level=mg_sparsity.min_level();
level<=mg_sparsity.max_level(); ++level)
{
- CompressedSparsityPattern c_sparsity(mgdofs.n_dofs(level));
- CompressedSparsityPattern ci_sparsity;
+ DynamicSparsityPattern c_sparsity(mgdofs.n_dofs(level));
+ DynamicSparsityPattern ci_sparsity;
if (level>0)
ci_sparsity.reinit(mgdofs.n_dofs(level-1), mgdofs.n_dofs(level));
-// Test BlockCompressedSimpleSparsityPattern column_number
+// Test BlockDynamicSparsityPattern column_number
#include "../tests.h"
deallog.attach(logfile);
deallog.threshold_double(1.e-10);
- BlockCompressedSimpleSparsityPattern csp(2,2);
+ BlockDynamicSparsityPattern csp(2,2);
csp.block(0,0).reinit(2,2);
csp.block(1,0).reinit(1,2);
csp.block(0,1).reinit(2,1);
-// Test BlockCompressedSimpleSparsityPattern with IndexSets
+// Test BlockDynamicSparsityPattern with IndexSets
#include "../tests.h"
part.push_back(a);
part.push_back(b);
part.push_back(a);
- BlockCompressedSimpleSparsityPattern csp(part);
+ BlockDynamicSparsityPattern csp(part);
deallog << "blocks: " << csp.n_block_rows() << "x" << csp.n_block_cols() << std::endl;
deallog << "size: " << csp.n_rows() << "x" << csp.n_cols() << std::endl;
col_blocks[1] = 3;
col_blocks[2] = 2;
- BlockCompressedSparsityPattern bcsp (row_blocks, col_blocks);
+ BlockDynamicSparsityPattern bcsp (row_blocks, col_blocks);
BlockSparsityPattern bsp;
row_blocks[0] = 10;
row_blocks[1] = 5;
- BlockCompressedSimpleSparsityPattern csp (row_blocks, row_blocks);
+ BlockDynamicSparsityPattern csp (row_blocks, row_blocks);
csp.reinit(2,2);
csp.block(0,0).reinit(10,10);
for (unsigned int i=0; i<sizeof(chunk_sizes)/sizeof(chunk_sizes[0]); ++i)
{
chunk_size = chunk_sizes[i];
- copy_from_2<ChunkSparsityPattern, CompressedSparsityPattern> ();
+ copy_from_2<ChunkSparsityPattern, DynamicSparsityPattern> ();
}
}
for (unsigned int i=0; i<sizeof(chunk_sizes)/sizeof(chunk_sizes[0]); ++i)
{
chunk_size = chunk_sizes[i];
- copy_from_2<ChunkSparsityPattern, CompressedSetSparsityPattern> ();
+ copy_from_2<ChunkSparsityPattern, DynamicSparsityPattern> ();
}
}
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2008 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSetSparsityPattern::print_gnuplot
-
-#include "sparsity_pattern_common.h"
-
-int main ()
-{
- std::ofstream logfile("output");
- logfile.setf(std::ios::fixed);
- deallog << std::setprecision(3);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- print_gnuplot<CompressedSetSparsityPattern> ();
-}
-
-
-
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2008 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSetSparsityPattern::copy operator with offdiagonals
-
-#include "sparsity_pattern_common.h"
-
-int main ()
-{
- std::ofstream logfile("output");
- logfile.setf(std::ios::fixed);
- deallog << std::setprecision(3);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- copy_with_offdiagonals_1<CompressedSetSparsityPattern> ();
-}
-
-
-
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2008 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSetSparsityPattern::copy constructor with offdiagonals
-
-#include "sparsity_pattern_common.h"
-
-int main ()
-{
- std::ofstream logfile("output");
- logfile.setf(std::ios::fixed);
- deallog << std::setprecision(3);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- copy_with_offdiagonals_2<CompressedSetSparsityPattern> ();
-}
-
-
-
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2008 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSetSparsityPattern::matrix_position
-
-#include "sparsity_pattern_common.h"
-
-int main ()
-{
- std::ofstream logfile("output");
- logfile.setf(std::ios::fixed);
- deallog << std::setprecision(3);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- matrix_position<CompressedSetSparsityPattern> ();
-}
-
-
-
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2008 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSetSparsityPattern::block_read/write
-
-#include "sparsity_pattern_common.h"
-
-int main ()
-{
- std::ofstream logfile("output");
- logfile.setf(std::ios::fixed);
- deallog << std::setprecision(3);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- block_read_write<CompressedSetSparsityPattern> ();
-}
-
-
-
+++ /dev/null
-
-DEAL::OK
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2008 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSimpleSparsityPattern::row_length
-
-#include "sparsity_pattern_common.h"
-
-int main ()
-{
- std::ofstream logfile("output");
- logfile.setf(std::ios::fixed);
- deallog << std::setprecision(3);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- row_length<CompressedSimpleSparsityPattern> ();
-}
-
-
-
+++ /dev/null
-
-DEAL::196 196 14 924
-DEAL::3
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::3
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::3
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::3
-DEAL::OK
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2008 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSimpleSparsityPattern::print_gnuplot
-
-#include "sparsity_pattern_common.h"
-
-int main ()
-{
- std::ofstream logfile("output");
- logfile.setf(std::ios::fixed);
- deallog << std::setprecision(3);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- print_gnuplot<CompressedSimpleSparsityPattern> ();
-}
-
-
-
+++ /dev/null
-
-DEAL::196 196 14 924
-0 0
-1 0
-14 0
-0 -1
-1 -1
-2 -1
-15 -1
-1 -2
-2 -2
-3 -2
-16 -2
-2 -3
-3 -3
-4 -3
-17 -3
-3 -4
-4 -4
-5 -4
-18 -4
-4 -5
-5 -5
-6 -5
-19 -5
-5 -6
-6 -6
-7 -6
-20 -6
-6 -7
-7 -7
-8 -7
-21 -7
-7 -8
-8 -8
-9 -8
-22 -8
-8 -9
-9 -9
-10 -9
-23 -9
-9 -10
-10 -10
-11 -10
-24 -10
-10 -11
-11 -11
-12 -11
-25 -11
-11 -12
-12 -12
-13 -12
-26 -12
-12 -13
-13 -13
-27 -13
-0 -14
-14 -14
-15 -14
-28 -14
-1 -15
-14 -15
-15 -15
-16 -15
-29 -15
-2 -16
-15 -16
-16 -16
-17 -16
-30 -16
-3 -17
-16 -17
-17 -17
-18 -17
-31 -17
-4 -18
-17 -18
-18 -18
-19 -18
-32 -18
-5 -19
-18 -19
-19 -19
-20 -19
-33 -19
-6 -20
-19 -20
-20 -20
-21 -20
-34 -20
-7 -21
-20 -21
-21 -21
-22 -21
-35 -21
-8 -22
-21 -22
-22 -22
-23 -22
-36 -22
-9 -23
-22 -23
-23 -23
-24 -23
-37 -23
-10 -24
-23 -24
-24 -24
-25 -24
-38 -24
-11 -25
-24 -25
-25 -25
-26 -25
-39 -25
-12 -26
-25 -26
-26 -26
-27 -26
-40 -26
-13 -27
-26 -27
-27 -27
-41 -27
-14 -28
-28 -28
-29 -28
-42 -28
-15 -29
-28 -29
-29 -29
-30 -29
-43 -29
-16 -30
-29 -30
-30 -30
-31 -30
-44 -30
-17 -31
-30 -31
-31 -31
-32 -31
-45 -31
-18 -32
-31 -32
-32 -32
-33 -32
-46 -32
-19 -33
-32 -33
-33 -33
-34 -33
-47 -33
-20 -34
-33 -34
-34 -34
-35 -34
-48 -34
-21 -35
-34 -35
-35 -35
-36 -35
-49 -35
-22 -36
-35 -36
-36 -36
-37 -36
-50 -36
-23 -37
-36 -37
-37 -37
-38 -37
-51 -37
-24 -38
-37 -38
-38 -38
-39 -38
-52 -38
-25 -39
-38 -39
-39 -39
-40 -39
-53 -39
-26 -40
-39 -40
-40 -40
-41 -40
-54 -40
-27 -41
-40 -41
-41 -41
-55 -41
-28 -42
-42 -42
-43 -42
-56 -42
-29 -43
-42 -43
-43 -43
-44 -43
-57 -43
-30 -44
-43 -44
-44 -44
-45 -44
-58 -44
-31 -45
-44 -45
-45 -45
-46 -45
-59 -45
-32 -46
-45 -46
-46 -46
-47 -46
-60 -46
-33 -47
-46 -47
-47 -47
-48 -47
-61 -47
-34 -48
-47 -48
-48 -48
-49 -48
-62 -48
-35 -49
-48 -49
-49 -49
-50 -49
-63 -49
-36 -50
-49 -50
-50 -50
-51 -50
-64 -50
-37 -51
-50 -51
-51 -51
-52 -51
-65 -51
-38 -52
-51 -52
-52 -52
-53 -52
-66 -52
-39 -53
-52 -53
-53 -53
-54 -53
-67 -53
-40 -54
-53 -54
-54 -54
-55 -54
-68 -54
-41 -55
-54 -55
-55 -55
-69 -55
-42 -56
-56 -56
-57 -56
-70 -56
-43 -57
-56 -57
-57 -57
-58 -57
-71 -57
-44 -58
-57 -58
-58 -58
-59 -58
-72 -58
-45 -59
-58 -59
-59 -59
-60 -59
-73 -59
-46 -60
-59 -60
-60 -60
-61 -60
-74 -60
-47 -61
-60 -61
-61 -61
-62 -61
-75 -61
-48 -62
-61 -62
-62 -62
-63 -62
-76 -62
-49 -63
-62 -63
-63 -63
-64 -63
-77 -63
-50 -64
-63 -64
-64 -64
-65 -64
-78 -64
-51 -65
-64 -65
-65 -65
-66 -65
-79 -65
-52 -66
-65 -66
-66 -66
-67 -66
-80 -66
-53 -67
-66 -67
-67 -67
-68 -67
-81 -67
-54 -68
-67 -68
-68 -68
-69 -68
-82 -68
-55 -69
-68 -69
-69 -69
-83 -69
-56 -70
-70 -70
-71 -70
-84 -70
-57 -71
-70 -71
-71 -71
-72 -71
-85 -71
-58 -72
-71 -72
-72 -72
-73 -72
-86 -72
-59 -73
-72 -73
-73 -73
-74 -73
-87 -73
-60 -74
-73 -74
-74 -74
-75 -74
-88 -74
-61 -75
-74 -75
-75 -75
-76 -75
-89 -75
-62 -76
-75 -76
-76 -76
-77 -76
-90 -76
-63 -77
-76 -77
-77 -77
-78 -77
-91 -77
-64 -78
-77 -78
-78 -78
-79 -78
-92 -78
-65 -79
-78 -79
-79 -79
-80 -79
-93 -79
-66 -80
-79 -80
-80 -80
-81 -80
-94 -80
-67 -81
-80 -81
-81 -81
-82 -81
-95 -81
-68 -82
-81 -82
-82 -82
-83 -82
-96 -82
-69 -83
-82 -83
-83 -83
-97 -83
-70 -84
-84 -84
-85 -84
-98 -84
-71 -85
-84 -85
-85 -85
-86 -85
-99 -85
-72 -86
-85 -86
-86 -86
-87 -86
-100 -86
-73 -87
-86 -87
-87 -87
-88 -87
-101 -87
-74 -88
-87 -88
-88 -88
-89 -88
-102 -88
-75 -89
-88 -89
-89 -89
-90 -89
-103 -89
-76 -90
-89 -90
-90 -90
-91 -90
-104 -90
-77 -91
-90 -91
-91 -91
-92 -91
-105 -91
-78 -92
-91 -92
-92 -92
-93 -92
-106 -92
-79 -93
-92 -93
-93 -93
-94 -93
-107 -93
-80 -94
-93 -94
-94 -94
-95 -94
-108 -94
-81 -95
-94 -95
-95 -95
-96 -95
-109 -95
-82 -96
-95 -96
-96 -96
-97 -96
-110 -96
-83 -97
-96 -97
-97 -97
-111 -97
-84 -98
-98 -98
-99 -98
-112 -98
-85 -99
-98 -99
-99 -99
-100 -99
-113 -99
-86 -100
-99 -100
-100 -100
-101 -100
-114 -100
-87 -101
-100 -101
-101 -101
-102 -101
-115 -101
-88 -102
-101 -102
-102 -102
-103 -102
-116 -102
-89 -103
-102 -103
-103 -103
-104 -103
-117 -103
-90 -104
-103 -104
-104 -104
-105 -104
-118 -104
-91 -105
-104 -105
-105 -105
-106 -105
-119 -105
-92 -106
-105 -106
-106 -106
-107 -106
-120 -106
-93 -107
-106 -107
-107 -107
-108 -107
-121 -107
-94 -108
-107 -108
-108 -108
-109 -108
-122 -108
-95 -109
-108 -109
-109 -109
-110 -109
-123 -109
-96 -110
-109 -110
-110 -110
-111 -110
-124 -110
-97 -111
-110 -111
-111 -111
-125 -111
-98 -112
-112 -112
-113 -112
-126 -112
-99 -113
-112 -113
-113 -113
-114 -113
-127 -113
-100 -114
-113 -114
-114 -114
-115 -114
-128 -114
-101 -115
-114 -115
-115 -115
-116 -115
-129 -115
-102 -116
-115 -116
-116 -116
-117 -116
-130 -116
-103 -117
-116 -117
-117 -117
-118 -117
-131 -117
-104 -118
-117 -118
-118 -118
-119 -118
-132 -118
-105 -119
-118 -119
-119 -119
-120 -119
-133 -119
-106 -120
-119 -120
-120 -120
-121 -120
-134 -120
-107 -121
-120 -121
-121 -121
-122 -121
-135 -121
-108 -122
-121 -122
-122 -122
-123 -122
-136 -122
-109 -123
-122 -123
-123 -123
-124 -123
-137 -123
-110 -124
-123 -124
-124 -124
-125 -124
-138 -124
-111 -125
-124 -125
-125 -125
-139 -125
-112 -126
-126 -126
-127 -126
-140 -126
-113 -127
-126 -127
-127 -127
-128 -127
-141 -127
-114 -128
-127 -128
-128 -128
-129 -128
-142 -128
-115 -129
-128 -129
-129 -129
-130 -129
-143 -129
-116 -130
-129 -130
-130 -130
-131 -130
-144 -130
-117 -131
-130 -131
-131 -131
-132 -131
-145 -131
-118 -132
-131 -132
-132 -132
-133 -132
-146 -132
-119 -133
-132 -133
-133 -133
-134 -133
-147 -133
-120 -134
-133 -134
-134 -134
-135 -134
-148 -134
-121 -135
-134 -135
-135 -135
-136 -135
-149 -135
-122 -136
-135 -136
-136 -136
-137 -136
-150 -136
-123 -137
-136 -137
-137 -137
-138 -137
-151 -137
-124 -138
-137 -138
-138 -138
-139 -138
-152 -138
-125 -139
-138 -139
-139 -139
-153 -139
-126 -140
-140 -140
-141 -140
-154 -140
-127 -141
-140 -141
-141 -141
-142 -141
-155 -141
-128 -142
-141 -142
-142 -142
-143 -142
-156 -142
-129 -143
-142 -143
-143 -143
-144 -143
-157 -143
-130 -144
-143 -144
-144 -144
-145 -144
-158 -144
-131 -145
-144 -145
-145 -145
-146 -145
-159 -145
-132 -146
-145 -146
-146 -146
-147 -146
-160 -146
-133 -147
-146 -147
-147 -147
-148 -147
-161 -147
-134 -148
-147 -148
-148 -148
-149 -148
-162 -148
-135 -149
-148 -149
-149 -149
-150 -149
-163 -149
-136 -150
-149 -150
-150 -150
-151 -150
-164 -150
-137 -151
-150 -151
-151 -151
-152 -151
-165 -151
-138 -152
-151 -152
-152 -152
-153 -152
-166 -152
-139 -153
-152 -153
-153 -153
-167 -153
-140 -154
-154 -154
-155 -154
-168 -154
-141 -155
-154 -155
-155 -155
-156 -155
-169 -155
-142 -156
-155 -156
-156 -156
-157 -156
-170 -156
-143 -157
-156 -157
-157 -157
-158 -157
-171 -157
-144 -158
-157 -158
-158 -158
-159 -158
-172 -158
-145 -159
-158 -159
-159 -159
-160 -159
-173 -159
-146 -160
-159 -160
-160 -160
-161 -160
-174 -160
-147 -161
-160 -161
-161 -161
-162 -161
-175 -161
-148 -162
-161 -162
-162 -162
-163 -162
-176 -162
-149 -163
-162 -163
-163 -163
-164 -163
-177 -163
-150 -164
-163 -164
-164 -164
-165 -164
-178 -164
-151 -165
-164 -165
-165 -165
-166 -165
-179 -165
-152 -166
-165 -166
-166 -166
-167 -166
-180 -166
-153 -167
-166 -167
-167 -167
-181 -167
-154 -168
-168 -168
-169 -168
-182 -168
-155 -169
-168 -169
-169 -169
-170 -169
-183 -169
-156 -170
-169 -170
-170 -170
-171 -170
-184 -170
-157 -171
-170 -171
-171 -171
-172 -171
-185 -171
-158 -172
-171 -172
-172 -172
-173 -172
-186 -172
-159 -173
-172 -173
-173 -173
-174 -173
-187 -173
-160 -174
-173 -174
-174 -174
-175 -174
-188 -174
-161 -175
-174 -175
-175 -175
-176 -175
-189 -175
-162 -176
-175 -176
-176 -176
-177 -176
-190 -176
-163 -177
-176 -177
-177 -177
-178 -177
-191 -177
-164 -178
-177 -178
-178 -178
-179 -178
-192 -178
-165 -179
-178 -179
-179 -179
-180 -179
-193 -179
-166 -180
-179 -180
-180 -180
-181 -180
-194 -180
-167 -181
-180 -181
-181 -181
-195 -181
-168 -182
-182 -182
-183 -182
-169 -183
-182 -183
-183 -183
-184 -183
-170 -184
-183 -184
-184 -184
-185 -184
-171 -185
-184 -185
-185 -185
-186 -185
-172 -186
-185 -186
-186 -186
-187 -186
-173 -187
-186 -187
-187 -187
-188 -187
-174 -188
-187 -188
-188 -188
-189 -188
-175 -189
-188 -189
-189 -189
-190 -189
-176 -190
-189 -190
-190 -190
-191 -190
-177 -191
-190 -191
-191 -191
-192 -191
-178 -192
-191 -192
-192 -192
-193 -192
-179 -193
-192 -193
-193 -193
-194 -193
-180 -194
-193 -194
-194 -194
-195 -194
-181 -195
-194 -195
-195 -195
-DEAL::OK
+++ /dev/null
-
-DEAL::196 196 14 924
-[0,0,1,14]
-[1,0,1,2,15]
-[2,1,2,3,16]
-[3,2,3,4,17]
-[4,3,4,5,18]
-[5,4,5,6,19]
-[6,5,6,7,20]
-[7,6,7,8,21]
-[8,7,8,9,22]
-[9,8,9,10,23]
-[10,9,10,11,24]
-[11,10,11,12,25]
-[12,11,12,13,26]
-[13,12,13,27]
-[14,0,14,15,28]
-[15,1,14,15,16,29]
-[16,2,15,16,17,30]
-[17,3,16,17,18,31]
-[18,4,17,18,19,32]
-[19,5,18,19,20,33]
-[20,6,19,20,21,34]
-[21,7,20,21,22,35]
-[22,8,21,22,23,36]
-[23,9,22,23,24,37]
-[24,10,23,24,25,38]
-[25,11,24,25,26,39]
-[26,12,25,26,27,40]
-[27,13,26,27,41]
-[28,14,28,29,42]
-[29,15,28,29,30,43]
-[30,16,29,30,31,44]
-[31,17,30,31,32,45]
-[32,18,31,32,33,46]
-[33,19,32,33,34,47]
-[34,20,33,34,35,48]
-[35,21,34,35,36,49]
-[36,22,35,36,37,50]
-[37,23,36,37,38,51]
-[38,24,37,38,39,52]
-[39,25,38,39,40,53]
-[40,26,39,40,41,54]
-[41,27,40,41,55]
-[42,28,42,43,56]
-[43,29,42,43,44,57]
-[44,30,43,44,45,58]
-[45,31,44,45,46,59]
-[46,32,45,46,47,60]
-[47,33,46,47,48,61]
-[48,34,47,48,49,62]
-[49,35,48,49,50,63]
-[50,36,49,50,51,64]
-[51,37,50,51,52,65]
-[52,38,51,52,53,66]
-[53,39,52,53,54,67]
-[54,40,53,54,55,68]
-[55,41,54,55,69]
-[56,42,56,57,70]
-[57,43,56,57,58,71]
-[58,44,57,58,59,72]
-[59,45,58,59,60,73]
-[60,46,59,60,61,74]
-[61,47,60,61,62,75]
-[62,48,61,62,63,76]
-[63,49,62,63,64,77]
-[64,50,63,64,65,78]
-[65,51,64,65,66,79]
-[66,52,65,66,67,80]
-[67,53,66,67,68,81]
-[68,54,67,68,69,82]
-[69,55,68,69,83]
-[70,56,70,71,84]
-[71,57,70,71,72,85]
-[72,58,71,72,73,86]
-[73,59,72,73,74,87]
-[74,60,73,74,75,88]
-[75,61,74,75,76,89]
-[76,62,75,76,77,90]
-[77,63,76,77,78,91]
-[78,64,77,78,79,92]
-[79,65,78,79,80,93]
-[80,66,79,80,81,94]
-[81,67,80,81,82,95]
-[82,68,81,82,83,96]
-[83,69,82,83,97]
-[84,70,84,85,98]
-[85,71,84,85,86,99]
-[86,72,85,86,87,100]
-[87,73,86,87,88,101]
-[88,74,87,88,89,102]
-[89,75,88,89,90,103]
-[90,76,89,90,91,104]
-[91,77,90,91,92,105]
-[92,78,91,92,93,106]
-[93,79,92,93,94,107]
-[94,80,93,94,95,108]
-[95,81,94,95,96,109]
-[96,82,95,96,97,110]
-[97,83,96,97,111]
-[98,84,98,99,112]
-[99,85,98,99,100,113]
-[100,86,99,100,101,114]
-[101,87,100,101,102,115]
-[102,88,101,102,103,116]
-[103,89,102,103,104,117]
-[104,90,103,104,105,118]
-[105,91,104,105,106,119]
-[106,92,105,106,107,120]
-[107,93,106,107,108,121]
-[108,94,107,108,109,122]
-[109,95,108,109,110,123]
-[110,96,109,110,111,124]
-[111,97,110,111,125]
-[112,98,112,113,126]
-[113,99,112,113,114,127]
-[114,100,113,114,115,128]
-[115,101,114,115,116,129]
-[116,102,115,116,117,130]
-[117,103,116,117,118,131]
-[118,104,117,118,119,132]
-[119,105,118,119,120,133]
-[120,106,119,120,121,134]
-[121,107,120,121,122,135]
-[122,108,121,122,123,136]
-[123,109,122,123,124,137]
-[124,110,123,124,125,138]
-[125,111,124,125,139]
-[126,112,126,127,140]
-[127,113,126,127,128,141]
-[128,114,127,128,129,142]
-[129,115,128,129,130,143]
-[130,116,129,130,131,144]
-[131,117,130,131,132,145]
-[132,118,131,132,133,146]
-[133,119,132,133,134,147]
-[134,120,133,134,135,148]
-[135,121,134,135,136,149]
-[136,122,135,136,137,150]
-[137,123,136,137,138,151]
-[138,124,137,138,139,152]
-[139,125,138,139,153]
-[140,126,140,141,154]
-[141,127,140,141,142,155]
-[142,128,141,142,143,156]
-[143,129,142,143,144,157]
-[144,130,143,144,145,158]
-[145,131,144,145,146,159]
-[146,132,145,146,147,160]
-[147,133,146,147,148,161]
-[148,134,147,148,149,162]
-[149,135,148,149,150,163]
-[150,136,149,150,151,164]
-[151,137,150,151,152,165]
-[152,138,151,152,153,166]
-[153,139,152,153,167]
-[154,140,154,155,168]
-[155,141,154,155,156,169]
-[156,142,155,156,157,170]
-[157,143,156,157,158,171]
-[158,144,157,158,159,172]
-[159,145,158,159,160,173]
-[160,146,159,160,161,174]
-[161,147,160,161,162,175]
-[162,148,161,162,163,176]
-[163,149,162,163,164,177]
-[164,150,163,164,165,178]
-[165,151,164,165,166,179]
-[166,152,165,166,167,180]
-[167,153,166,167,181]
-[168,154,168,169,182]
-[169,155,168,169,170,183]
-[170,156,169,170,171,184]
-[171,157,170,171,172,185]
-[172,158,171,172,173,186]
-[173,159,172,173,174,187]
-[174,160,173,174,175,188]
-[175,161,174,175,176,189]
-[176,162,175,176,177,190]
-[177,163,176,177,178,191]
-[178,164,177,178,179,192]
-[179,165,178,179,180,193]
-[180,166,179,180,181,194]
-[181,167,180,181,195]
-[182,168,182,183]
-[183,169,182,183,184]
-[184,170,183,184,185]
-[185,171,184,185,186]
-[186,172,185,186,187]
-[187,173,186,187,188]
-[188,174,187,188,189]
-[189,175,188,189,190]
-[190,176,189,190,191]
-[191,177,190,191,192]
-[192,178,191,192,193]
-[193,179,192,193,194]
-[194,180,193,194,195]
-[195,181,194,195]
-DEAL::OK
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2008 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSimpleSparsityPattern::copy operator with offdiagonals
-
-#include "sparsity_pattern_common.h"
-
-int main ()
-{
- std::ofstream logfile("output");
- logfile.setf(std::ios::fixed);
- deallog << std::setprecision(3);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- copy_with_offdiagonals_1<CompressedSimpleSparsityPattern> ();
-}
-
-
-
+++ /dev/null
-
-DEAL::OK
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2008 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSimpleSparsityPattern::copy constructor with offdiagonals
-
-#include "sparsity_pattern_common.h"
-
-int main ()
-{
- std::ofstream logfile("output");
- logfile.setf(std::ios::fixed);
- deallog << std::setprecision(3);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- copy_with_offdiagonals_2<CompressedSimpleSparsityPattern> ();
-}
-
-
-
+++ /dev/null
-
-DEAL::OK
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2008 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSimpleSparsityPattern::matrix_position
-
-#include "sparsity_pattern_common.h"
-
-int main ()
-{
- std::ofstream logfile("output");
- logfile.setf(std::ios::fixed);
- deallog << std::setprecision(3);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- matrix_position<CompressedSimpleSparsityPattern> ();
-}
-
-
-
+++ /dev/null
-
-DEAL::OK
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2008 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSimpleSparsityPattern::block_read/write
-
-#include "sparsity_pattern_common.h"
-
-int main ()
-{
- std::ofstream logfile("output");
- logfile.setf(std::ios::fixed);
- deallog << std::setprecision(3);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- block_read_write<CompressedSimpleSparsityPattern> ();
-}
-
-
-
+++ /dev/null
-
-DEAL::OK
+++ /dev/null
-
-DEAL::196 196 14 924
-DEAL::3
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::3
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::4
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::5
-DEAL::4
-DEAL::3
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::4
-DEAL::3
-DEAL::OK
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2008 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSparsityPattern::print_gnuplot
-
-#include "sparsity_pattern_common.h"
-
-int main ()
-{
- std::ofstream logfile("output");
- logfile.setf(std::ios::fixed);
- deallog << std::setprecision(3);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- print_gnuplot<CompressedSparsityPattern> ();
-}
-
-
-
+++ /dev/null
-
-DEAL::196 196 14 924
-0 0
-1 0
-14 0
-0 -1
-1 -1
-2 -1
-15 -1
-1 -2
-2 -2
-3 -2
-16 -2
-2 -3
-3 -3
-4 -3
-17 -3
-3 -4
-4 -4
-5 -4
-18 -4
-4 -5
-5 -5
-6 -5
-19 -5
-5 -6
-6 -6
-7 -6
-20 -6
-6 -7
-7 -7
-8 -7
-21 -7
-7 -8
-8 -8
-9 -8
-22 -8
-8 -9
-9 -9
-10 -9
-23 -9
-9 -10
-10 -10
-11 -10
-24 -10
-10 -11
-11 -11
-12 -11
-25 -11
-11 -12
-12 -12
-13 -12
-26 -12
-12 -13
-13 -13
-27 -13
-0 -14
-14 -14
-15 -14
-28 -14
-1 -15
-14 -15
-15 -15
-16 -15
-29 -15
-2 -16
-15 -16
-16 -16
-17 -16
-30 -16
-3 -17
-16 -17
-17 -17
-18 -17
-31 -17
-4 -18
-17 -18
-18 -18
-19 -18
-32 -18
-5 -19
-18 -19
-19 -19
-20 -19
-33 -19
-6 -20
-19 -20
-20 -20
-21 -20
-34 -20
-7 -21
-20 -21
-21 -21
-22 -21
-35 -21
-8 -22
-21 -22
-22 -22
-23 -22
-36 -22
-9 -23
-22 -23
-23 -23
-24 -23
-37 -23
-10 -24
-23 -24
-24 -24
-25 -24
-38 -24
-11 -25
-24 -25
-25 -25
-26 -25
-39 -25
-12 -26
-25 -26
-26 -26
-27 -26
-40 -26
-13 -27
-26 -27
-27 -27
-41 -27
-14 -28
-28 -28
-29 -28
-42 -28
-15 -29
-28 -29
-29 -29
-30 -29
-43 -29
-16 -30
-29 -30
-30 -30
-31 -30
-44 -30
-17 -31
-30 -31
-31 -31
-32 -31
-45 -31
-18 -32
-31 -32
-32 -32
-33 -32
-46 -32
-19 -33
-32 -33
-33 -33
-34 -33
-47 -33
-20 -34
-33 -34
-34 -34
-35 -34
-48 -34
-21 -35
-34 -35
-35 -35
-36 -35
-49 -35
-22 -36
-35 -36
-36 -36
-37 -36
-50 -36
-23 -37
-36 -37
-37 -37
-38 -37
-51 -37
-24 -38
-37 -38
-38 -38
-39 -38
-52 -38
-25 -39
-38 -39
-39 -39
-40 -39
-53 -39
-26 -40
-39 -40
-40 -40
-41 -40
-54 -40
-27 -41
-40 -41
-41 -41
-55 -41
-28 -42
-42 -42
-43 -42
-56 -42
-29 -43
-42 -43
-43 -43
-44 -43
-57 -43
-30 -44
-43 -44
-44 -44
-45 -44
-58 -44
-31 -45
-44 -45
-45 -45
-46 -45
-59 -45
-32 -46
-45 -46
-46 -46
-47 -46
-60 -46
-33 -47
-46 -47
-47 -47
-48 -47
-61 -47
-34 -48
-47 -48
-48 -48
-49 -48
-62 -48
-35 -49
-48 -49
-49 -49
-50 -49
-63 -49
-36 -50
-49 -50
-50 -50
-51 -50
-64 -50
-37 -51
-50 -51
-51 -51
-52 -51
-65 -51
-38 -52
-51 -52
-52 -52
-53 -52
-66 -52
-39 -53
-52 -53
-53 -53
-54 -53
-67 -53
-40 -54
-53 -54
-54 -54
-55 -54
-68 -54
-41 -55
-54 -55
-55 -55
-69 -55
-42 -56
-56 -56
-57 -56
-70 -56
-43 -57
-56 -57
-57 -57
-58 -57
-71 -57
-44 -58
-57 -58
-58 -58
-59 -58
-72 -58
-45 -59
-58 -59
-59 -59
-60 -59
-73 -59
-46 -60
-59 -60
-60 -60
-61 -60
-74 -60
-47 -61
-60 -61
-61 -61
-62 -61
-75 -61
-48 -62
-61 -62
-62 -62
-63 -62
-76 -62
-49 -63
-62 -63
-63 -63
-64 -63
-77 -63
-50 -64
-63 -64
-64 -64
-65 -64
-78 -64
-51 -65
-64 -65
-65 -65
-66 -65
-79 -65
-52 -66
-65 -66
-66 -66
-67 -66
-80 -66
-53 -67
-66 -67
-67 -67
-68 -67
-81 -67
-54 -68
-67 -68
-68 -68
-69 -68
-82 -68
-55 -69
-68 -69
-69 -69
-83 -69
-56 -70
-70 -70
-71 -70
-84 -70
-57 -71
-70 -71
-71 -71
-72 -71
-85 -71
-58 -72
-71 -72
-72 -72
-73 -72
-86 -72
-59 -73
-72 -73
-73 -73
-74 -73
-87 -73
-60 -74
-73 -74
-74 -74
-75 -74
-88 -74
-61 -75
-74 -75
-75 -75
-76 -75
-89 -75
-62 -76
-75 -76
-76 -76
-77 -76
-90 -76
-63 -77
-76 -77
-77 -77
-78 -77
-91 -77
-64 -78
-77 -78
-78 -78
-79 -78
-92 -78
-65 -79
-78 -79
-79 -79
-80 -79
-93 -79
-66 -80
-79 -80
-80 -80
-81 -80
-94 -80
-67 -81
-80 -81
-81 -81
-82 -81
-95 -81
-68 -82
-81 -82
-82 -82
-83 -82
-96 -82
-69 -83
-82 -83
-83 -83
-97 -83
-70 -84
-84 -84
-85 -84
-98 -84
-71 -85
-84 -85
-85 -85
-86 -85
-99 -85
-72 -86
-85 -86
-86 -86
-87 -86
-100 -86
-73 -87
-86 -87
-87 -87
-88 -87
-101 -87
-74 -88
-87 -88
-88 -88
-89 -88
-102 -88
-75 -89
-88 -89
-89 -89
-90 -89
-103 -89
-76 -90
-89 -90
-90 -90
-91 -90
-104 -90
-77 -91
-90 -91
-91 -91
-92 -91
-105 -91
-78 -92
-91 -92
-92 -92
-93 -92
-106 -92
-79 -93
-92 -93
-93 -93
-94 -93
-107 -93
-80 -94
-93 -94
-94 -94
-95 -94
-108 -94
-81 -95
-94 -95
-95 -95
-96 -95
-109 -95
-82 -96
-95 -96
-96 -96
-97 -96
-110 -96
-83 -97
-96 -97
-97 -97
-111 -97
-84 -98
-98 -98
-99 -98
-112 -98
-85 -99
-98 -99
-99 -99
-100 -99
-113 -99
-86 -100
-99 -100
-100 -100
-101 -100
-114 -100
-87 -101
-100 -101
-101 -101
-102 -101
-115 -101
-88 -102
-101 -102
-102 -102
-103 -102
-116 -102
-89 -103
-102 -103
-103 -103
-104 -103
-117 -103
-90 -104
-103 -104
-104 -104
-105 -104
-118 -104
-91 -105
-104 -105
-105 -105
-106 -105
-119 -105
-92 -106
-105 -106
-106 -106
-107 -106
-120 -106
-93 -107
-106 -107
-107 -107
-108 -107
-121 -107
-94 -108
-107 -108
-108 -108
-109 -108
-122 -108
-95 -109
-108 -109
-109 -109
-110 -109
-123 -109
-96 -110
-109 -110
-110 -110
-111 -110
-124 -110
-97 -111
-110 -111
-111 -111
-125 -111
-98 -112
-112 -112
-113 -112
-126 -112
-99 -113
-112 -113
-113 -113
-114 -113
-127 -113
-100 -114
-113 -114
-114 -114
-115 -114
-128 -114
-101 -115
-114 -115
-115 -115
-116 -115
-129 -115
-102 -116
-115 -116
-116 -116
-117 -116
-130 -116
-103 -117
-116 -117
-117 -117
-118 -117
-131 -117
-104 -118
-117 -118
-118 -118
-119 -118
-132 -118
-105 -119
-118 -119
-119 -119
-120 -119
-133 -119
-106 -120
-119 -120
-120 -120
-121 -120
-134 -120
-107 -121
-120 -121
-121 -121
-122 -121
-135 -121
-108 -122
-121 -122
-122 -122
-123 -122
-136 -122
-109 -123
-122 -123
-123 -123
-124 -123
-137 -123
-110 -124
-123 -124
-124 -124
-125 -124
-138 -124
-111 -125
-124 -125
-125 -125
-139 -125
-112 -126
-126 -126
-127 -126
-140 -126
-113 -127
-126 -127
-127 -127
-128 -127
-141 -127
-114 -128
-127 -128
-128 -128
-129 -128
-142 -128
-115 -129
-128 -129
-129 -129
-130 -129
-143 -129
-116 -130
-129 -130
-130 -130
-131 -130
-144 -130
-117 -131
-130 -131
-131 -131
-132 -131
-145 -131
-118 -132
-131 -132
-132 -132
-133 -132
-146 -132
-119 -133
-132 -133
-133 -133
-134 -133
-147 -133
-120 -134
-133 -134
-134 -134
-135 -134
-148 -134
-121 -135
-134 -135
-135 -135
-136 -135
-149 -135
-122 -136
-135 -136
-136 -136
-137 -136
-150 -136
-123 -137
-136 -137
-137 -137
-138 -137
-151 -137
-124 -138
-137 -138
-138 -138
-139 -138
-152 -138
-125 -139
-138 -139
-139 -139
-153 -139
-126 -140
-140 -140
-141 -140
-154 -140
-127 -141
-140 -141
-141 -141
-142 -141
-155 -141
-128 -142
-141 -142
-142 -142
-143 -142
-156 -142
-129 -143
-142 -143
-143 -143
-144 -143
-157 -143
-130 -144
-143 -144
-144 -144
-145 -144
-158 -144
-131 -145
-144 -145
-145 -145
-146 -145
-159 -145
-132 -146
-145 -146
-146 -146
-147 -146
-160 -146
-133 -147
-146 -147
-147 -147
-148 -147
-161 -147
-134 -148
-147 -148
-148 -148
-149 -148
-162 -148
-135 -149
-148 -149
-149 -149
-150 -149
-163 -149
-136 -150
-149 -150
-150 -150
-151 -150
-164 -150
-137 -151
-150 -151
-151 -151
-152 -151
-165 -151
-138 -152
-151 -152
-152 -152
-153 -152
-166 -152
-139 -153
-152 -153
-153 -153
-167 -153
-140 -154
-154 -154
-155 -154
-168 -154
-141 -155
-154 -155
-155 -155
-156 -155
-169 -155
-142 -156
-155 -156
-156 -156
-157 -156
-170 -156
-143 -157
-156 -157
-157 -157
-158 -157
-171 -157
-144 -158
-157 -158
-158 -158
-159 -158
-172 -158
-145 -159
-158 -159
-159 -159
-160 -159
-173 -159
-146 -160
-159 -160
-160 -160
-161 -160
-174 -160
-147 -161
-160 -161
-161 -161
-162 -161
-175 -161
-148 -162
-161 -162
-162 -162
-163 -162
-176 -162
-149 -163
-162 -163
-163 -163
-164 -163
-177 -163
-150 -164
-163 -164
-164 -164
-165 -164
-178 -164
-151 -165
-164 -165
-165 -165
-166 -165
-179 -165
-152 -166
-165 -166
-166 -166
-167 -166
-180 -166
-153 -167
-166 -167
-167 -167
-181 -167
-154 -168
-168 -168
-169 -168
-182 -168
-155 -169
-168 -169
-169 -169
-170 -169
-183 -169
-156 -170
-169 -170
-170 -170
-171 -170
-184 -170
-157 -171
-170 -171
-171 -171
-172 -171
-185 -171
-158 -172
-171 -172
-172 -172
-173 -172
-186 -172
-159 -173
-172 -173
-173 -173
-174 -173
-187 -173
-160 -174
-173 -174
-174 -174
-175 -174
-188 -174
-161 -175
-174 -175
-175 -175
-176 -175
-189 -175
-162 -176
-175 -176
-176 -176
-177 -176
-190 -176
-163 -177
-176 -177
-177 -177
-178 -177
-191 -177
-164 -178
-177 -178
-178 -178
-179 -178
-192 -178
-165 -179
-178 -179
-179 -179
-180 -179
-193 -179
-166 -180
-179 -180
-180 -180
-181 -180
-194 -180
-167 -181
-180 -181
-181 -181
-195 -181
-168 -182
-182 -182
-183 -182
-169 -183
-182 -183
-183 -183
-184 -183
-170 -184
-183 -184
-184 -184
-185 -184
-171 -185
-184 -185
-185 -185
-186 -185
-172 -186
-185 -186
-186 -186
-187 -186
-173 -187
-186 -187
-187 -187
-188 -187
-174 -188
-187 -188
-188 -188
-189 -188
-175 -189
-188 -189
-189 -189
-190 -189
-176 -190
-189 -190
-190 -190
-191 -190
-177 -191
-190 -191
-191 -191
-192 -191
-178 -192
-191 -192
-192 -192
-193 -192
-179 -193
-192 -193
-193 -193
-194 -193
-180 -194
-193 -194
-194 -194
-195 -194
-181 -195
-194 -195
-195 -195
-DEAL::OK
+++ /dev/null
-
-DEAL::196 196 14 924
-[0,0,1,14]
-[1,0,1,2,15]
-[2,1,2,3,16]
-[3,2,3,4,17]
-[4,3,4,5,18]
-[5,4,5,6,19]
-[6,5,6,7,20]
-[7,6,7,8,21]
-[8,7,8,9,22]
-[9,8,9,10,23]
-[10,9,10,11,24]
-[11,10,11,12,25]
-[12,11,12,13,26]
-[13,12,13,27]
-[14,0,14,15,28]
-[15,1,14,15,16,29]
-[16,2,15,16,17,30]
-[17,3,16,17,18,31]
-[18,4,17,18,19,32]
-[19,5,18,19,20,33]
-[20,6,19,20,21,34]
-[21,7,20,21,22,35]
-[22,8,21,22,23,36]
-[23,9,22,23,24,37]
-[24,10,23,24,25,38]
-[25,11,24,25,26,39]
-[26,12,25,26,27,40]
-[27,13,26,27,41]
-[28,14,28,29,42]
-[29,15,28,29,30,43]
-[30,16,29,30,31,44]
-[31,17,30,31,32,45]
-[32,18,31,32,33,46]
-[33,19,32,33,34,47]
-[34,20,33,34,35,48]
-[35,21,34,35,36,49]
-[36,22,35,36,37,50]
-[37,23,36,37,38,51]
-[38,24,37,38,39,52]
-[39,25,38,39,40,53]
-[40,26,39,40,41,54]
-[41,27,40,41,55]
-[42,28,42,43,56]
-[43,29,42,43,44,57]
-[44,30,43,44,45,58]
-[45,31,44,45,46,59]
-[46,32,45,46,47,60]
-[47,33,46,47,48,61]
-[48,34,47,48,49,62]
-[49,35,48,49,50,63]
-[50,36,49,50,51,64]
-[51,37,50,51,52,65]
-[52,38,51,52,53,66]
-[53,39,52,53,54,67]
-[54,40,53,54,55,68]
-[55,41,54,55,69]
-[56,42,56,57,70]
-[57,43,56,57,58,71]
-[58,44,57,58,59,72]
-[59,45,58,59,60,73]
-[60,46,59,60,61,74]
-[61,47,60,61,62,75]
-[62,48,61,62,63,76]
-[63,49,62,63,64,77]
-[64,50,63,64,65,78]
-[65,51,64,65,66,79]
-[66,52,65,66,67,80]
-[67,53,66,67,68,81]
-[68,54,67,68,69,82]
-[69,55,68,69,83]
-[70,56,70,71,84]
-[71,57,70,71,72,85]
-[72,58,71,72,73,86]
-[73,59,72,73,74,87]
-[74,60,73,74,75,88]
-[75,61,74,75,76,89]
-[76,62,75,76,77,90]
-[77,63,76,77,78,91]
-[78,64,77,78,79,92]
-[79,65,78,79,80,93]
-[80,66,79,80,81,94]
-[81,67,80,81,82,95]
-[82,68,81,82,83,96]
-[83,69,82,83,97]
-[84,70,84,85,98]
-[85,71,84,85,86,99]
-[86,72,85,86,87,100]
-[87,73,86,87,88,101]
-[88,74,87,88,89,102]
-[89,75,88,89,90,103]
-[90,76,89,90,91,104]
-[91,77,90,91,92,105]
-[92,78,91,92,93,106]
-[93,79,92,93,94,107]
-[94,80,93,94,95,108]
-[95,81,94,95,96,109]
-[96,82,95,96,97,110]
-[97,83,96,97,111]
-[98,84,98,99,112]
-[99,85,98,99,100,113]
-[100,86,99,100,101,114]
-[101,87,100,101,102,115]
-[102,88,101,102,103,116]
-[103,89,102,103,104,117]
-[104,90,103,104,105,118]
-[105,91,104,105,106,119]
-[106,92,105,106,107,120]
-[107,93,106,107,108,121]
-[108,94,107,108,109,122]
-[109,95,108,109,110,123]
-[110,96,109,110,111,124]
-[111,97,110,111,125]
-[112,98,112,113,126]
-[113,99,112,113,114,127]
-[114,100,113,114,115,128]
-[115,101,114,115,116,129]
-[116,102,115,116,117,130]
-[117,103,116,117,118,131]
-[118,104,117,118,119,132]
-[119,105,118,119,120,133]
-[120,106,119,120,121,134]
-[121,107,120,121,122,135]
-[122,108,121,122,123,136]
-[123,109,122,123,124,137]
-[124,110,123,124,125,138]
-[125,111,124,125,139]
-[126,112,126,127,140]
-[127,113,126,127,128,141]
-[128,114,127,128,129,142]
-[129,115,128,129,130,143]
-[130,116,129,130,131,144]
-[131,117,130,131,132,145]
-[132,118,131,132,133,146]
-[133,119,132,133,134,147]
-[134,120,133,134,135,148]
-[135,121,134,135,136,149]
-[136,122,135,136,137,150]
-[137,123,136,137,138,151]
-[138,124,137,138,139,152]
-[139,125,138,139,153]
-[140,126,140,141,154]
-[141,127,140,141,142,155]
-[142,128,141,142,143,156]
-[143,129,142,143,144,157]
-[144,130,143,144,145,158]
-[145,131,144,145,146,159]
-[146,132,145,146,147,160]
-[147,133,146,147,148,161]
-[148,134,147,148,149,162]
-[149,135,148,149,150,163]
-[150,136,149,150,151,164]
-[151,137,150,151,152,165]
-[152,138,151,152,153,166]
-[153,139,152,153,167]
-[154,140,154,155,168]
-[155,141,154,155,156,169]
-[156,142,155,156,157,170]
-[157,143,156,157,158,171]
-[158,144,157,158,159,172]
-[159,145,158,159,160,173]
-[160,146,159,160,161,174]
-[161,147,160,161,162,175]
-[162,148,161,162,163,176]
-[163,149,162,163,164,177]
-[164,150,163,164,165,178]
-[165,151,164,165,166,179]
-[166,152,165,166,167,180]
-[167,153,166,167,181]
-[168,154,168,169,182]
-[169,155,168,169,170,183]
-[170,156,169,170,171,184]
-[171,157,170,171,172,185]
-[172,158,171,172,173,186]
-[173,159,172,173,174,187]
-[174,160,173,174,175,188]
-[175,161,174,175,176,189]
-[176,162,175,176,177,190]
-[177,163,176,177,178,191]
-[178,164,177,178,179,192]
-[179,165,178,179,180,193]
-[180,166,179,180,181,194]
-[181,167,180,181,195]
-[182,168,182,183]
-[183,169,182,183,184]
-[184,170,183,184,185]
-[185,171,184,185,186]
-[186,172,185,186,187]
-[187,173,186,187,188]
-[188,174,187,188,189]
-[189,175,188,189,190]
-[190,176,189,190,191]
-[191,177,190,191,192]
-[192,178,191,192,193]
-[193,179,192,193,194]
-[194,180,193,194,195]
-[195,181,194,195]
-DEAL::OK
+++ /dev/null
-
-DEAL::OK
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2008 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSparsityPattern::copy constructor with offdiagonals
-
-#include "sparsity_pattern_common.h"
-
-int main ()
-{
- std::ofstream logfile("output");
- logfile.setf(std::ios::fixed);
- deallog << std::setprecision(3);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- copy_with_offdiagonals_2<CompressedSparsityPattern> ();
-}
-
-
-
+++ /dev/null
-
-DEAL::OK
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2008 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSparsityPattern::matrix_position
-
-#include "sparsity_pattern_common.h"
-
-int main ()
-{
- std::ofstream logfile("output");
- logfile.setf(std::ios::fixed);
- deallog << std::setprecision(3);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- matrix_position<CompressedSparsityPattern> ();
-}
-
-
-
+++ /dev/null
-
-DEAL::OK
+++ /dev/null
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 2008 - 2015 by the deal.II authors
-//
-// This file is part of the deal.II library.
-//
-// The deal.II library is free software; you can use it, redistribute
-// it, and/or modify it under the terms of the GNU Lesser General
-// Public License as published by the Free Software Foundation; either
-// version 2.1 of the License, or (at your option) any later version.
-// The full text of the license can be found in the file LICENSE at
-// the top level of the deal.II distribution.
-//
-// ---------------------------------------------------------------------
-
-
-
-// check CompressedSparsityPattern::block_read/write
-
-#include "sparsity_pattern_common.h"
-
-int main ()
-{
- std::ofstream logfile("output");
- logfile.setf(std::ios::fixed);
- deallog << std::setprecision(3);
- deallog.attach(logfile);
- deallog.threshold_double(1.e-10);
-
- block_read_write<CompressedSparsityPattern> ();
-}
-
-
-
+++ /dev/null
-
-DEAL::OK
#include <deal.II/lac/vector.h>
#include <deal.II/lac/sparse_direct.h>
#include <deal.II/lac/full_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/sparse_matrix.h>
#include <deal.II/lac/constraint_matrix.h>
BlockSparsityPattern block_sparsity_pattern;
{
- BlockCompressedSimpleSparsityPattern csp(3,3);
+ BlockDynamicSparsityPattern csp(3,3);
csp.block(0,0).reinit (dofs_per_block[0],dofs_per_block[0]);//solid-solid
csp.block(0,1).reinit (dofs_per_block[0],dofs_per_block[1]);//solid-fluid
csp.block(0,2).reinit (dofs_per_block[0],dofs_per_block[2]);//solid-mesh
#include <deal.II/lac/constraint_matrix.h>
#include <deal.II/fe/fe_q.h>
#include <deal.II/numerics/vector_tools.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <fstream>
#include <iostream>
SparsityPattern sparsity;
{
- CompressedSimpleSparsityPattern csp (dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp (dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, csp, constraints, false);
sparsity.copy_from (csp);
}
#include <deal.II/lac/constraint_matrix.h>
#include <deal.II/fe/fe_q.h>
#include <deal.II/numerics/vector_tools.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <fstream>
#include <iostream>
SparsityPattern sparsity;
ChunkSparsityPattern chunk_sparsity;
{
- CompressedSimpleSparsityPattern csp (dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp (dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, csp, constraints, false);
sparsity.copy_from (csp);
chunk_sparsity.copy_from (csp, chunk_size);
-// check CompressedSetSparsityPattern::print
+// check DynamicSparsityPattern::row_length
#include "sparsity_pattern_common.h"
deallog.attach(logfile);
deallog.threshold_double(1.e-10);
- print<CompressedSetSparsityPattern> ();
+ row_length<DynamicSparsityPattern> ();
}
-// check CompressedSparsityPattern::row_length
+// check DynamicSparsityPattern::print_gnuplot
#include "sparsity_pattern_common.h"
deallog.attach(logfile);
deallog.threshold_double(1.e-10);
- row_length<CompressedSparsityPattern> ();
+ print_gnuplot<DynamicSparsityPattern> ();
}
-// check CompressedSparsityPattern::print
+// check DynamicSparsityPattern::print
#include "sparsity_pattern_common.h"
deallog.attach(logfile);
deallog.threshold_double(1.e-10);
- print<CompressedSparsityPattern> ();
+ print<DynamicSparsityPattern> ();
}
-// check SparsityPattern::copy_from
+// check DynamicSparsityPattern::copy operator with offdiagonals
#include "sparsity_pattern_common.h"
deallog.attach(logfile);
deallog.threshold_double(1.e-10);
- copy_from_2<SparsityPattern, CompressedSetSparsityPattern> ();
+ copy_with_offdiagonals_1<DynamicSparsityPattern> ();
}
-// check CompressedSparsityPattern::copy operator with offdiagonals
+// check DynamicSparsityPattern::copy constructor with offdiagonals
#include "sparsity_pattern_common.h"
deallog.attach(logfile);
deallog.threshold_double(1.e-10);
- copy_with_offdiagonals_1<CompressedSparsityPattern> ();
+ copy_with_offdiagonals_2<DynamicSparsityPattern> ();
}
-// check CompressedSimpleSparsityPattern::print
+// check DynamicSparsityPattern::matrix_position
#include "sparsity_pattern_common.h"
deallog.attach(logfile);
deallog.threshold_double(1.e-10);
- print<CompressedSimpleSparsityPattern> ();
+ matrix_position<DynamicSparsityPattern> ();
}
-// check CompressedSetSparsityPattern::row_length
+// check DynamicSparsityPattern::block_read/write
#include "sparsity_pattern_common.h"
deallog.attach(logfile);
deallog.threshold_double(1.e-10);
- row_length<CompressedSetSparsityPattern> ();
+ block_read_write<DynamicSparsityPattern> ();
}
-// check CompressedSimpleSparsityPattern with an IndexSet that stores
+// check DynamicSparsityPattern with an IndexSet that stores
// a contiguous range
#include "sparsity_pattern_common.h"
deallog.attach(logfile);
deallog.threshold_double(1.e-10);
- test_index_set<CompressedSimpleSparsityPattern> (true);
+ test_index_set<DynamicSparsityPattern> (true);
}
-// check CompressedSimpleSparsityPattern with an IndexSet that stores
+// check DynamicSparsityPattern with an IndexSet that stores
// a non-contiguous range
#include "sparsity_pattern_common.h"
deallog.attach(logfile);
deallog.threshold_double(1.e-10);
- test_index_set<CompressedSimpleSparsityPattern> (false);
+ test_index_set<DynamicSparsityPattern> (false);
}
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
#include <deal.II/numerics/error_estimator.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/hp/dof_handler.h>
#include <deal.II/hp/fe_values.h>
}
test_all_constraints.close ();
- CompressedSimpleSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp,
hanging_nodes_only, true);
sparsity_pattern.copy_from (csp);
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
#include <deal.II/numerics/error_estimator.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <fstream>
#include <iostream>
cm.print(logfile);
- CompressedSimpleSparsityPattern csp(5,5);
+ DynamicSparsityPattern csp(5,5);
for (unsigned int i=0; i<5; ++i)
csp.add(i,i);
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
#include <deal.II/numerics/error_estimator.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <fstream>
#include <iostream>
cm.print(logfile);
- CompressedSimpleSparsityPattern csp(8,8);
+ DynamicSparsityPattern csp(8,8);
for (unsigned int i=0; i<8; ++i)
csp.add(i,i);
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
#include <deal.II/numerics/error_estimator.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <fstream>
#include <iostream>
void test(bool use_constraint_matrix)
{
- CompressedSimpleSparsityPattern csp(8,8);
+ DynamicSparsityPattern csp(8,8);
for (unsigned int i=0; i<8; ++i)
csp.add(i,i);
hanging_nodes_only.close ();
test_all_constraints.close ();
- BlockCompressedSimpleSparsityPattern csp (2,2);
+ BlockDynamicSparsityPattern csp (2,2);
{
const unsigned int dofs_per_block = dof_handler.n_dofs() / 2;
csp.block(0,0).reinit (dofs_per_block, dofs_per_block);
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
#include <deal.II/numerics/error_estimator.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <fstream>
#include <iostream>
hanging_nodes_only.close ();
test_all_constraints.close ();
- CompressedSimpleSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp,
hanging_nodes_only, true);
sparsity_pattern.copy_from (csp);
#include <deal.II/base/logstream.h>
#include <deal.II/lac/block_sparse_matrix.h>
#include <deal.II/lac/sparsity_pattern.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/block_sparsity_pattern.h>
#include <deal.II/lac/block_sparse_matrix_ez.h>
#include <deal.II/lac/constraint_matrix.h>
<< IsBlockMatrix<BlockSparseMatrixEZ<float> >::value << std::endl;
deallog << IsBlockMatrix<SparsityPattern>::value << ' '
- << IsBlockMatrix<CompressedSparsityPattern>::value << ' '
- << IsBlockMatrix<CompressedSetSparsityPattern>::value << ' '
- << IsBlockMatrix<CompressedSimpleSparsityPattern>::value << std::endl;
+ << IsBlockMatrix<DynamicSparsityPattern>::value << std::endl;
deallog << IsBlockMatrix<BlockSparsityPattern>::value << ' '
- << IsBlockMatrix<BlockCompressedSparsityPattern>::value << ' '
- << IsBlockMatrix<BlockCompressedSetSparsityPattern>::value << ' '
- << IsBlockMatrix<BlockCompressedSimpleSparsityPattern>::value << std::endl;
+ << IsBlockMatrix<BlockDynamicSparsityPattern>::value << std::endl;
}
const unsigned int rc=10;
BlockSparsityPattern sparsity_pattern;
{
- BlockCompressedSimpleSparsityPattern csp(blks, blks);
+ BlockDynamicSparsityPattern csp(blks, blks);
for (unsigned int bi=0; bi<blks; ++bi)
for (unsigned int bj=0; bj<blks; ++bj)
csp.block(bi,bj).reinit(rc,rc);
const unsigned int rc=10;
BlockSparsityPattern sparsity_pattern;
{
- BlockCompressedSimpleSparsityPattern csp(blks, blks);
+ BlockDynamicSparsityPattern csp(blks, blks);
for (unsigned int bi=0; bi<blks; ++bi)
for (unsigned int bj=0; bj<blks; ++bj)
csp.block(bi,bj).reinit(rc,rc);
deallog.attach(logfile);
deallog.threshold_double(1.e-10);
- copy_from_2<SparsityPattern, CompressedSparsityPattern> ();
+ copy_from_2<SparsityPattern, DynamicSparsityPattern> ();
}
+++ /dev/null
-
-DEAL::196 196 14 924
-DEAL::OK
deallog.attach(logfile);
deallog.threshold_double(1.e-10);
- copy_from_2<SparsityPattern, CompressedSimpleSparsityPattern> ();
+ copy_from_2<SparsityPattern, DynamicSparsityPattern> ();
}
#include <deal.II/base/index_set.h>
#include <deal.II/lac/sparsity_pattern.h>
#include <deal.II/lac/dynamic_sparsity_pattern.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
-#include <deal.II/lac/compressed_set_sparsity_pattern.h>
#include <deal.II/lac/chunk_sparsity_pattern.h>
#include <deal.II/lac/full_matrix.h>
#include "testmatrix.h"
-void do_reinit (CompressedSimpleSparsityPattern &sp,
+void do_reinit (DynamicSparsityPattern &sp,
const IndexSet &index_set = IndexSet())
{
sp.reinit((N-1)*(N-1), (N-1)*(N-1), index_set);
#include "../tests.h"
#include <deal.II/base/logstream.h>
#include <deal.II/lac/sparsity_pattern.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include "testmatrix.h"
#include <fstream>
#include <iomanip>
deallog.attach(logfile);
deallog.threshold_double(1.e-10);
- CompressedSparsityPattern csp (10, 0);
+ DynamicSparsityPattern csp (10, 0);
SparsityPattern sp;
sp.copy_from (csp);
// << std::endl;
{
- BlockCompressedSimpleSparsityPattern csp (2,2);
+ BlockDynamicSparsityPattern csp (2,2);
for (unsigned int d=0; d<2; ++d)
for (unsigned int e=0; e<2; ++e)
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/lac/constraint_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/fe/fe_q.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/numerics/vector_tools.h>
// assemble sparse matrix with (\nabla v, \nabla u) + (v, 10 * u)
SparsityPattern sparsity;
{
- CompressedSimpleSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, csp, constraints, true);
sparsity.copy_from(csp);
}
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/lac/constraint_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/fe/fe_q.h>
#include <deal.II/fe/fe_system.h>
#include <deal.II/fe/fe_values.h>
// (v, 10 * u)
SparsityPattern sparsity;
{
- CompressedSimpleSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, csp, constraints, true);
sparsity.copy_from(csp);
}
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/lac/constraint_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/fe/fe_q.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/numerics/vector_tools.h>
// assemble sparse matrix with (\nabla v, \nabla u + 3.2221 * \nabla^2 u * ones) + (v, 10 * u)
SparsityPattern sparsity;
{
- CompressedSimpleSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, csp, constraints, true);
sparsity.copy_from(csp);
}
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/lac/constraint_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/fe/fe_q.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/numerics/vector_tools.h>
// assemble sparse matrix with (\nabla v, \nabla u) + (v, 10 * u)
SparsityPattern sparsity;
{
- CompressedSimpleSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, csp, constraints, true);
sparsity.copy_from(csp);
}
const unsigned int dofs_per_block = dof_handler_sca.n_dofs();
{
- BlockCompressedSimpleSparsityPattern csp (dim,dim);
+ BlockDynamicSparsityPattern csp (dim,dim);
for (unsigned int d=0; d<dim; ++d)
for (unsigned int e=0; e<dim; ++e)
csp.block(d,e).reinit (dofs_per_block, dofs_per_block);
const unsigned int dofs_per_block = dof_handler_sca.n_dofs();
{
- BlockCompressedSimpleSparsityPattern csp (dim,dim);
+ BlockDynamicSparsityPattern csp (dim,dim);
for (unsigned int d=0; d<dim; ++d)
for (unsigned int e=0; e<dim; ++e)
csp.block(d,e).reinit (dofs_per_block, dofs_per_block);
ZeroFunction<dim>(),
constraints);
constraints.close ();
- CompressedSimpleSparsityPattern csp (dof.n_dofs(),
- dof.n_dofs());
+ DynamicSparsityPattern csp (dof.n_dofs(),
+ dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, csp, constraints, false);
SparsityPattern sparsity;
sparsity.copy_from (csp);
SparsityPattern sparsity;
SparseMatrix<double> system_matrix;
{
- CompressedSimpleSparsityPattern csp (dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp (dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (static_cast<const DoFHandler<dim>&>(dof),
csp, constraints, false);
sparsity.copy_from (csp);
data.level_mg_handler = level;
mg_matrices[level].reinit(dof, mg_constraints[level], quad, data);
- CompressedSimpleSparsityPattern csp;
+ DynamicSparsityPattern csp;
csp.reinit (dof.n_dofs(level), dof.n_dofs(level));
MGTools::make_sparsity_pattern (dof, csp, level);
mg_sparsities[level].copy_from (csp);
// << std::endl;
{
- BlockCompressedSimpleSparsityPattern csp (dim+1,dim+1);
+ BlockDynamicSparsityPattern csp (dim+1,dim+1);
for (unsigned int d=0; d<dim+1; ++d)
for (unsigned int e=0; e<dim+1; ++e)
// << std::endl;
{
- BlockCompressedSimpleSparsityPattern csp (2,2);
+ BlockDynamicSparsityPattern csp (2,2);
for (unsigned int d=0; d<2; ++d)
for (unsigned int e=0; e<2; ++e)
// << std::endl;
{
- BlockCompressedSimpleSparsityPattern csp (dim+1,dim+1);
+ BlockDynamicSparsityPattern csp (dim+1,dim+1);
for (unsigned int d=0; d<dim+1; ++d)
for (unsigned int e=0; e<dim+1; ++e)
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/lac/constraint_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/trilinos_vector.h>
#include <deal.II/fe/fe_q.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/lac/constraint_matrix.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/trilinos_vector.h>
#include <deal.II/fe/fe_q.h>
#include <deal.II/fe/fe_values.h>
#include <deal.II/base/index_set.h>
#include <deal.II/lac/sparsity_tools.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <fstream>
if (myid<numprocs-1)
locally_rel.add_range((myid+1)*num_local, (myid+2)*num_local);
- CompressedSimpleSparsityPattern csp(n,n, locally_rel);
+ DynamicSparsityPattern csp(n,n, locally_rel);
for (unsigned int i=0; i<n; ++i)
csp.add(i, myid);
-// check SparsityTools::distribute_sparsity_pattern for BlockCompressedSimpleSP
+// check SparsityTools::distribute_sparsity_pattern for BlockDynamicSP
#include "../tests.h"
#include <deal.II/base/logstream.h>
#include <deal.II/base/index_set.h>
#include <deal.II/lac/sparsity_tools.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/block_sparsity_pattern.h>
#include <fstream>
std::vector<IndexSet> partitioning;
partitioning.push_back(locally_rel);
- BlockCompressedSimpleSparsityPattern csp(partitioning);
+ BlockDynamicSparsityPattern csp(partitioning);
for (unsigned int i=0; i<n; ++i)
csp.add(i, myid);
#include "../tests.h"
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/precondition.h>
#include <deal.II/lac/precondition_block.h>
DoFTools::extract_locally_relevant_dofs (dof_handler, locally_relevant_set);
- CompressedSimpleSparsityPattern c_sparsity(dof_handler.n_dofs(), dof_handler.n_dofs());
+ DynamicSparsityPattern c_sparsity(dof_handler.n_dofs(), dof_handler.n_dofs());
DoFTools::make_flux_sparsity_pattern(dof_handler, c_sparsity);
matrix.reinit(dof_handler.locally_owned_dofs(), c_sparsity, MPI_COMM_WORLD, true);
for (unsigned int level=mg_matrix.min_level();
level<=mg_matrix.max_level(); ++level)
{
- CompressedSimpleSparsityPattern c_sparsity(dof_handler.n_dofs(level));
+ DynamicSparsityPattern c_sparsity(dof_handler.n_dofs(level));
MGTools::make_flux_sparsity_pattern(dof_handler, c_sparsity, level);
mg_matrix[level].reinit(dof_handler.locally_owned_mg_dofs(level),
dof_handler.locally_owned_mg_dofs(level),
if (level>0)
{
- CompressedSimpleSparsityPattern ci_sparsity;
+ DynamicSparsityPattern ci_sparsity;
ci_sparsity.reinit(dof_handler.n_dofs(level-1), dof_handler.n_dofs(level));
MGTools::make_flux_sparsity_pattern_edge(dof_handler, ci_sparsity, level);
#include <deal.II/lac/vector.h>
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/constraint_matrix.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/trilinos_vector.h>
#include <deal.II/lac/petsc_parallel_vector.h>
#include <deal.II/lac/solver_control.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/precondition.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/numerics/data_out.h>
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
ZeroFunction<dim>(),
constraints);
constraints.close ();
- CompressedSimpleSparsityPattern csp (locally_relevant_dofs);
+ DynamicSparsityPattern csp (locally_relevant_dofs);
DoFTools::make_sparsity_pattern (dof_handler, csp,
constraints, false);
SparsityTools::distribute_sparsity_pattern (csp,
TrilinosWrappers::SparseMatrix matrix;
const FiniteElement<dim> &fe = dofs.get_fe();
- CompressedSimpleSparsityPattern csp(dofs.n_dofs(), dofs.n_dofs());
+ DynamicSparsityPattern csp(dofs.n_dofs(), dofs.n_dofs());
DoFTools::make_flux_sparsity_pattern (dofs, csp);
matrix.reinit (dofs.locally_owned_dofs(), csp, MPI_COMM_WORLD, true);
constraints.close ();
hanging_node_constraints.close ();
- CompressedSimpleSparsityPattern csp(mg_dof_handler.n_dofs(), mg_dof_handler.n_dofs());
+ DynamicSparsityPattern csp(mg_dof_handler.n_dofs(), mg_dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (mg_dof_handler, csp, constraints);
system_matrix.reinit (mg_dof_handler.locally_owned_dofs(), csp, MPI_COMM_WORLD, true);
for (unsigned int level=0; level<n_levels; ++level)
{
- CompressedSparsityPattern csp;
+ DynamicSparsityPattern csp;
csp.reinit(mg_dof_handler.n_dofs(level),
mg_dof_handler.n_dofs(level));
MGTools::make_sparsity_pattern(mg_dof_handler, csp, level);
constraints.close ();
hanging_node_constraints.close ();
- CompressedSimpleSparsityPattern csp(mg_dof_handler.n_dofs(), mg_dof_handler.n_dofs());
+ DynamicSparsityPattern csp(mg_dof_handler.n_dofs(), mg_dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (mg_dof_handler, csp, constraints);
system_matrix.reinit (mg_dof_handler.locally_owned_dofs(), csp, MPI_COMM_WORLD, true);
for (unsigned int level=0; level<n_levels; ++level)
{
- CompressedSparsityPattern csp;
+ DynamicSparsityPattern csp;
csp.reinit(mg_dof_handler.n_dofs(level),
mg_dof_handler.n_dofs(level));
MGTools::make_sparsity_pattern(mg_dof_handler, csp, level);
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/constraint_matrix.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/petsc_parallel_sparse_matrix.h>
#include <deal.II/lac/petsc_parallel_vector.h>
#include <deal.II/lac/petsc_solver.h>
DoFTools::make_hanging_node_constraints (dof_handler, constraints);
constraints.close ();
- CompressedSimpleSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs(),
- locally_relevant_dofs);
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs(),
+ locally_relevant_dofs);
DoFTools::make_sparsity_pattern (dof_handler,
csp,
constraints, false);
#include "../tests.h"
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/petsc_sparse_matrix.h>
#include <deal.II/lac/petsc_parallel_sparse_matrix.h>
#include <deal.II/base/logstream.h>
if (myid==0)
deallog << "Running on " << numprocs << " CPU(s)." << std::endl;
- CompressedSimpleSparsityPattern csp(2*numprocs);
+ DynamicSparsityPattern csp(2*numprocs);
for (unsigned int i=0; i<numprocs*2; ++i)
csp.add(i,i);
csp.add(1,0);
#include "../tests.h"
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/petsc_sparse_matrix.h>
#include <deal.II/lac/petsc_parallel_sparse_matrix.h>
#include <deal.II/base/logstream.h>
if (myid==0)
deallog << "Running on " << numprocs << " CPU(s)." << std::endl;
- CompressedSimpleSparsityPattern csp(2);
+ DynamicSparsityPattern csp(2);
csp.add(0,0);
csp.add(1,1);
#include <deal.II/lac/petsc_precondition.h>
#include <deal.II/lac/petsc_solver.h>
#include <deal.II/lac/petsc_vector.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/vector.h>
#include <deal.II/lac/sparsity_tools.h>
#include <deal.II/lac/solver_control.h>
#include "../tests.h"
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/vector.h>
#include <deal.II/base/logstream.h>
#include <deal.II/base/utilities.h>
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/constraint_matrix.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/petsc_parallel_sparse_matrix.h>
#include <deal.II/lac/petsc_parallel_vector.h>
constraints);
constraints.close ();
- CompressedSimpleSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs(),
- locally_relevant_dofs);
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs(),
+ locally_relevant_dofs);
DoFTools::make_sparsity_pattern (dof_handler,
csp,
constraints, false);
#include <deal.II/lac/full_matrix.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/constraint_matrix.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/petsc_parallel_sparse_matrix.h>
#include <deal.II/lac/petsc_parallel_vector.h>
constraints);
constraints.close ();
- CompressedSimpleSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs(),
- locally_relevant_dofs);
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs(),
+ locally_relevant_dofs);
DoFTools::make_sparsity_pattern (dof_handler,
csp,
constraints, false);
#include "../tests.h"
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/precondition.h>
#include <deal.II/lac/precondition_block.h>
for (unsigned int level=0; level<n_levels; ++level)
{
- CompressedSparsityPattern csp;
+ DynamicSparsityPattern csp;
csp.reinit(mg_dof_handler.n_dofs(level),
mg_dof_handler.n_dofs(level));
MGTools::make_sparsity_pattern(mg_dof_handler, csp, level);
for (unsigned int level=min_level; level<n_levels; ++level)
{
- CompressedSparsityPattern csp;
+ DynamicSparsityPattern csp;
csp.reinit(mg_dof_handler.n_dofs(level),
mg_dof_handler.n_dofs(level));
MGTools::make_sparsity_pattern(mg_dof_handler, csp, level);
for (unsigned int level=min_level; level<n_levels; ++level)
{
- CompressedSparsityPattern csp;
+ DynamicSparsityPattern csp;
csp.reinit(mg_dof_handler.n_dofs(level),
mg_dof_handler.n_dofs(level));
MGTools::make_sparsity_pattern(mg_dof_handler, csp, level);
for (unsigned int level=0; level<n_levels; ++level)
{
- CompressedSparsityPattern csp;
+ DynamicSparsityPattern csp;
csp.reinit(mg_dof_handler.n_dofs(level),
mg_dof_handler.n_dofs(level));
MGTools::make_sparsity_pattern(mg_dof_handler, csp, level);
for (unsigned int level=0; level<n_levels; ++level)
{
- CompressedSparsityPattern csp;
+ DynamicSparsityPattern csp;
csp.reinit(mg_dof_handler.n_dofs(level),
mg_dof_handler.n_dofs(level));
MGTools::make_sparsity_pattern(mg_dof_handler, csp, level);
for (unsigned int level=0; level<n_levels; ++level)
{
- CompressedSparsityPattern csp;
+ DynamicSparsityPattern csp;
csp.reinit(mg_dof_handler.n_dofs(level),
mg_dof_handler.n_dofs(level));
MGTools::make_sparsity_pattern(mg_dof_handler, csp, level);
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
#include <deal.II/numerics/error_estimator.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/hp/dof_handler.h>
#include <deal.II/hp/fe_values.h>
(std_cxx11::bind(&LaplaceProblem<dim>::get_conflict_indices, this,std_cxx11::_1)));
- CompressedSimpleSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp,
constraints, false);
sparsity_pattern.copy_from (csp);
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
#include <deal.II/numerics/error_estimator.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/hp/dof_handler.h>
#include <deal.II/hp/fe_values.h>
(std_cxx11::bind(&LaplaceProblem<dim>::get_conflict_indices, this,std_cxx11::_1)));
- CompressedSimpleSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp,
constraints, false);
sparsity_pattern.copy_from (csp);
(std_cxx11::bind(&LaplaceProblem<dim>::get_conflict_indices, this,std_cxx11::_1)));
- BlockCompressedSimpleSparsityPattern csp (2, 2);
+ BlockDynamicSparsityPattern csp (2, 2);
for (unsigned int i=0; i<2; ++i)
for (unsigned int j=0; j<2; ++j)
csp.block(i,j).reinit(i==0 ? 30 : dof_handler.n_dofs() - 30,
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
#include <deal.II/numerics/error_estimator.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/hp/dof_handler.h>
#include <deal.II/hp/fe_values.h>
(std_cxx11::bind(&LaplaceProblem<dim>::get_conflict_indices, this,std_cxx11::_1)));
- CompressedSimpleSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp,
constraints, true);
sparsity_pattern.copy_from (csp);
#include <deal.II/base/logstream.h>
#include <deal.II/base/function_lib.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/vector.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
// not couple, so use pattern
SparsityPattern sparsity;
{
- CompressedSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, csp, constraints);
sparsity.copy_from(csp);
}
#include <deal.II/base/logstream.h>
#include <deal.II/base/function_lib.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/vector.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
Table<2,DoFTools::Coupling> mask (2, 2);
mask(0,0) = mask(1,1) = DoFTools::always;
mask(0,1) = mask(1,0) = DoFTools::none;
- CompressedSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, mask, csp, constraints);
sparsity.copy_from(csp);
}
#include <deal.II/base/logstream.h>
#include <deal.II/base/function_lib.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/vector.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
Table<2,DoFTools::Coupling> mask (2, 2);
mask(0,0) = mask(1,1) = DoFTools::always;
mask(0,1) = mask(1,0) = DoFTools::none;
- CompressedSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, mask, csp, constraints);
sparsity.copy_from(csp);
}
#include <deal.II/base/logstream.h>
#include <deal.II/base/function_lib.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/vector.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
// not couple, so use pattern
SparsityPattern sparsity;
{
- CompressedSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, csp, constraints);
sparsity.copy_from(csp);
}
#include <deal.II/base/logstream.h>
#include <deal.II/base/function_lib.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/vector.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
Table<2,DoFTools::Coupling> mask (2, 2);
mask(0,0) = mask(1,1) = DoFTools::always;
mask(0,1) = mask(1,0) = DoFTools::none;
- CompressedSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, mask, csp, constraints);
sparsity.copy_from(csp);
}
#include <deal.II/base/logstream.h>
#include <deal.II/base/function_lib.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/vector.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
// not couple, so use pattern
SparsityPattern sparsity;
{
- CompressedSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, csp, constraints);
sparsity.copy_from(csp);
}
#include <deal.II/base/logstream.h>
#include <deal.II/base/function_lib.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/vector.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
Table<2,DoFTools::Coupling> mask (2, 2);
mask(0,0) = mask(1,1) = DoFTools::always;
mask(0,1) = mask(1,0) = DoFTools::none;
- CompressedSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, mask, csp, constraints);
sparsity.copy_from(csp);
}
#include <deal.II/base/logstream.h>
#include <deal.II/base/function_lib.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/vector.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
Table<2,DoFTools::Coupling> mask (2, 2);
mask(0,0) = mask(1,1) = DoFTools::always;
mask(0,1) = mask(1,0) = DoFTools::none;
- CompressedSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, mask, csp, constraints);
sparsity.copy_from(csp);
}
#include <deal.II/base/logstream.h>
#include <deal.II/base/function_lib.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/vector.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
// not couple, so use pattern
SparsityPattern sparsity;
{
- CompressedSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, csp, constraints);
sparsity.copy_from(csp);
}
#include <deal.II/base/logstream.h>
#include <deal.II/base/function_lib.h>
#include <deal.II/lac/sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/vector.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/tria_iterator.h>
Table<2,DoFTools::Coupling> mask (2, 2);
mask(0,0) = mask(1,1) = DoFTools::always;
mask(0,1) = mask(1,0) = DoFTools::none;
- CompressedSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
+ DynamicSparsityPattern csp(dof.n_dofs(), dof.n_dofs());
DoFTools::make_sparsity_pattern (dof, mask, csp, constraints);
sparsity.copy_from(csp);
}
#include <deal.II/base/function.h>\r
#include <deal.II/base/logstream.h>\r
#include <deal.II/lac/constraint_matrix.h>\r
-#include <deal.II/lac/compressed_sparsity_pattern.h>\r
+#include <deal.II/lac/dynamic_sparsity_pattern.h>\r
#include <deal.II/grid/tria.h>\r
#include <deal.II/grid/grid_generator.h>\r
#include <deal.II/dofs/dof_handler.h>\r
-// PETScWrappers::MPI::SparseMatrix::reinit(CompressedSparsityPattern) should
+// PETScWrappers::MPI::SparseMatrix::reinit(DynamicSparsityPattern) should
// create a matrix that, when filled with elements that match the sparsity
// pattern, doesn't require any more memory allocation any more. This is
// tricky to get right, though, and took a while until it worked.
#include "../tests.h"
#include <deal.II/lac/petsc_parallel_sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <fstream>
#include <cstdlib>
// used to allocate additional memory for 2
// processes. note that only one of the
// four blocks uses Inodes
- CompressedSparsityPattern csp (N,N);
+ DynamicSparsityPattern csp (N,N);
for (unsigned int i=0; i<N; ++i)
for (unsigned int j=0; j<N; ++j)
{
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <algorithm>
#include <iomanip>
i, -1);
mean_value_constraints.close ();
- CompressedSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp);
mean_value_constraints.condense (csp);
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
#include <deal.II/numerics/error_estimator.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/hp/dof_handler.h>
#include <deal.II/hp/fe_values.h>
(std_cxx11::bind(&LaplaceProblem<dim>::get_conflict_indices, this,std_cxx11::_1)));
- CompressedSimpleSparsityPattern csp (dof_handler.n_dofs(),
- dof_handler.n_dofs());
+ DynamicSparsityPattern csp (dof_handler.n_dofs(),
+ dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, csp,
constraints, false);
reference_matrix.reinit (dof_handler.locally_owned_dofs(), csp, MPI_COMM_WORLD);
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
#include <deal.II/numerics/error_estimator.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <fstream>
#include <iostream>
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
#include <deal.II/numerics/error_estimator.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <fstream>
#include <iostream>
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
#include <deal.II/numerics/error_estimator.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <fstream>
#include <iostream>
// tests thread safety of parallel Trilinos matrices. Same test as
// parallel_matrix_assemble_02 but initializing the matrix from
-// CompressedSimpleSparsityPattern instead of a Trilinos sparsity pattern.
+// DynamicSparsityPattern instead of a Trilinos sparsity pattern.
#include "../tests.h"
#include <deal.II/lac/trilinos_sparse_matrix.h>
#include <deal.II/lac/constraint_matrix.h>
#include <deal.II/lac/trilinos_sparsity_pattern.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/trilinos_vector.h>
#include <deal.II/grid/tria.h>
#include <deal.II/grid/grid_generator.h>
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
#include <deal.II/numerics/error_estimator.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <fstream>
#include <iostream>
{
IndexSet relevant_set;
DoFTools::extract_locally_relevant_dofs (dof_handler, relevant_set);
- CompressedSimpleSparsityPattern csp(dof_handler.n_dofs(), dof_handler.n_dofs(),
- relevant_set);
+ DynamicSparsityPattern csp(dof_handler.n_dofs(), dof_handler.n_dofs(),
+ relevant_set);
DoFTools::make_sparsity_pattern (dof_handler, csp,
constraints, false);
test_matrix.reinit (locally_owned, csp, MPI_COMM_WORLD, true);
// tests thread safety of parallel Trilinos block matrices. Same test as
// parallel_matrix_assemble_04 but initializing the matrix from
-// BlockCompressedSimpleSparsityPattern instead of a Trilinos sparsity pattern.
+// BlockDynamicSparsityPattern instead of a Trilinos sparsity pattern.
#include "../tests.h"
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
#include <deal.II/numerics/error_estimator.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <fstream>
#include <iostream>
reference_rhs.reinit (locally_owned, MPI_COMM_WORLD);
}
{
- BlockCompressedSimpleSparsityPattern csp(relevant_set);
+ BlockDynamicSparsityPattern csp(relevant_set);
DoFTools::make_sparsity_pattern (dof_handler, csp,
constraints, false);
test_matrix.reinit (locally_owned, csp, MPI_COMM_WORLD, true);
#include <deal.II/numerics/vector_tools.h>
#include <deal.II/numerics/matrix_tools.h>
#include <deal.II/numerics/error_estimator.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <fstream>
#include <iostream>
// Make matrix
FDMatrix testproblem(size, size);
- CompressedSimpleSparsityPattern csp (dim, dim);
+ DynamicSparsityPattern csp (dim, dim);
testproblem.five_point_structure(csp);
TrilinosWrappers::SparseMatrix A;
A.reinit(csp);
// Make matrix
FDMatrix testproblem(size, size);
- CompressedSimpleSparsityPattern csp (dim, dim);
+ DynamicSparsityPattern csp (dim, dim);
testproblem.five_point_structure(csp);
TrilinosWrappers::SparseMatrix A;
A.reinit(csp);
// Make matrix
FDMatrix testproblem(size, size);
- CompressedSimpleSparsityPattern csp (dim, dim);
+ DynamicSparsityPattern csp (dim, dim);
testproblem.five_point_structure(csp);
TrilinosWrappers::SparseMatrix A;
A.reinit(csp);
// Make matrix
FDMatrix testproblem(size, size);
- CompressedSimpleSparsityPattern csp (dim, dim);
+ DynamicSparsityPattern csp (dim, dim);
testproblem.five_point_structure(csp);
TrilinosWrappers::SparseMatrix A;
A.reinit(csp);
// Make matrix
FDMatrix testproblem(size, size);
- CompressedSimpleSparsityPattern csp (dim, dim);
+ DynamicSparsityPattern csp (dim, dim);
testproblem.five_point_structure(csp);
TrilinosWrappers::SparseMatrix A;
A.reinit(csp);
// Make matrix
FDMatrix testproblem(size, size);
- CompressedSimpleSparsityPattern csp (dim, dim);
+ DynamicSparsityPattern csp (dim, dim);
testproblem.five_point_structure(csp);
TrilinosWrappers::SparseMatrix A;
A.reinit(csp);
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/lac/vector.h>
#include <deal.II/lac/constraint_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/trilinos_solver.h>
#include <deal.II/dofs/dof_tools.h>
constraints);
constraints.close();
- CompressedSparsityPattern c_sparsity(dof_handler.n_dofs());
+ DynamicSparsityPattern c_sparsity(dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, c_sparsity, constraints, false);
system_matrix.reinit (c_sparsity);
-// TrilinosWrappers::SparseMatrix::reinit(CompressedSparsityPattern) should
+// TrilinosWrappers::SparseMatrix::reinit(DynamicSparsityPattern) should
// create a matrix that, when filled with elements that match the sparsity
// pattern, doesn't require any more memory allocation any more. This is
// tricky to get right, though, and took a while until it worked.
#include "../tests.h"
#include <deal.II/base/utilities.h>
#include <deal.II/lac/trilinos_sparse_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <fstream>
#include <cstdlib>
// used to allocate additional memory for 2
// processes. note that only one of the
// four blocks uses Inodes
- CompressedSparsityPattern csp (N,N);
+ DynamicSparsityPattern csp (N,N);
for (unsigned int i=0; i<N; ++i)
for (unsigned int j=0; j<N; ++j)
{
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/lac/vector.h>
#include <deal.II/lac/constraint_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/lac/solver_bicgstab.h>
#include <deal.II/dofs/dof_tools.h>
constraints);
constraints.close();
- CompressedSparsityPattern c_sparsity(dof_handler.n_dofs());
+ DynamicSparsityPattern c_sparsity(dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, c_sparsity, constraints, false);
system_matrix.reinit (c_sparsity);
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/lac/vector.h>
#include <deal.II/lac/constraint_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/dofs/dof_tools.h>
#include <deal.II/numerics/vector_tools.h>
{
dof_handler.distribute_dofs (fe);
- CompressedSparsityPattern c_sparsity(dof_handler.n_dofs());
+ DynamicSparsityPattern c_sparsity(dof_handler.n_dofs());
DoFTools::make_flux_sparsity_pattern (dof_handler, c_sparsity);
system_matrix.reinit (c_sparsity);
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/lac/vector.h>
#include <deal.II/lac/constraint_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/dofs/dof_tools.h>
#include <deal.II/numerics/vector_tools.h>
constraints);
constraints.close();
- CompressedSparsityPattern c_sparsity(dof_handler.n_dofs());
+ DynamicSparsityPattern c_sparsity(dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, c_sparsity, constraints, false);
system_matrix.reinit (c_sparsity);
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/lac/vector.h>
#include <deal.II/lac/constraint_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/dofs/dof_tools.h>
#include <deal.II/numerics/vector_tools.h>
{
dof_handler.distribute_dofs (fe);
- CompressedSparsityPattern c_sparsity(dof_handler.n_dofs());
+ DynamicSparsityPattern c_sparsity(dof_handler.n_dofs());
DoFTools::make_flux_sparsity_pattern (dof_handler, c_sparsity);
system_matrix.reinit (c_sparsity);
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/lac/vector.h>
#include <deal.II/lac/constraint_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/dofs/dof_tools.h>
#include <deal.II/numerics/vector_tools.h>
constraints);
constraints.close();
- CompressedSparsityPattern c_sparsity(dof_handler.n_dofs());
+ DynamicSparsityPattern c_sparsity(dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, c_sparsity, constraints, false);
system_matrix.reinit (c_sparsity);
preconditioner_matrix.reinit(c_sparsity);
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/lac/vector.h>
#include <deal.II/lac/constraint_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/dofs/dof_tools.h>
#include <deal.II/numerics/vector_tools.h>
constraints);
constraints.close();
- CompressedSparsityPattern c_sparsity(dof_handler.n_dofs());
+ DynamicSparsityPattern c_sparsity(dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, c_sparsity, constraints, false);
system_matrix.reinit (c_sparsity);
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/lac/vector.h>
#include <deal.II/lac/constraint_matrix.h>
-#include <deal.II/lac/compressed_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/solver_cg.h>
#include <deal.II/dofs/dof_tools.h>
#include <deal.II/numerics/vector_tools.h>
constraints);
constraints.close();
- CompressedSparsityPattern c_sparsity(dof_handler.n_dofs());
+ DynamicSparsityPattern c_sparsity(dof_handler.n_dofs());
DoFTools::make_sparsity_pattern (dof_handler, c_sparsity, constraints, false);
system_matrix.reinit (c_sparsity);
preconditioner_matrix.reinit(c_sparsity);
// Make matrix
FDMatrix testproblem(size, size);
- CompressedSimpleSparsityPattern csp (dim, dim);
+ DynamicSparsityPattern csp (dim, dim);
testproblem.five_point_structure(csp);
TrilinosWrappers::SparseMatrix A;
A.reinit(csp);
// Make matrix
FDMatrix testproblem(size, size);
- CompressedSimpleSparsityPattern csp (dim, dim);
+ DynamicSparsityPattern csp (dim, dim);
testproblem.five_point_structure(csp);
TrilinosWrappers::SparseMatrix A;
A.reinit(csp);
// Make matrix
FDMatrix testproblem(size, size);
- CompressedSimpleSparsityPattern csp (dim, dim);
+ DynamicSparsityPattern csp (dim, dim);
testproblem.five_point_structure(csp);
TrilinosWrappers::SparseMatrix A;
A.reinit(csp);
#include <fstream>
#include <iomanip>
#include <deal.II/base/logstream.h>
-#include <deal.II/lac/compressed_simple_sparsity_pattern.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
#include <deal.II/lac/trilinos_sparse_matrix.h>