## ---------------------------------------------------------------------
## $Id$
##
-## Copyright (C) 2013 by the deal.II authors
+## Copyright (C) 2013, 2014 by the deal.II authors
##
## This file is part of the deal.II library.
##
# "Nightly" - Reserved for nightly regression tests for
# build bots on various architectures
#
-# "Regression Tests" - Reserved for the regression tester
+# "Regression Tests" - Reserved for the "official" regression tester
#
# CONFIG_FILE
# - A configuration file (see ../deal.II/docs/development/Config.sample)
MESSAGE("-- CTEST_SITE: ${CTEST_SITE}")
IF( "${TRACK}" STREQUAL "Regression Tests"
- AND NOT CTEST_SITE MATCHES "c0541" )
+ AND NOT CTEST_SITE MATCHES "tester" )
MESSAGE(FATAL_ERROR "
I'm sorry ${CTEST_SITE}, I'm afraid I can't do that.
The TRACK \"Regression Tests\" is not for you.
ops_startline = ["<li>", "@param", "@returns", "@warning", "@ingroup", "@author", "@date", "@related", "@deprecated"]
- ops_separate_line = ["<ul>", "</ul>", "@{", "@}"]
+ ops_separate_line = ["<ol>", "</ol>", "<ul>", "</ul>", "@{", "@}", "<br>"]
while idx<endidx:
if one_in(ops_separate_line, lines[idx]):
<h3>Specific improvements</h3>
<ol>
+ <li> Fixed: GridTools::find_active_cell_around_point() could get into an infinite
+ loop if the point we are looking for is in fact not within the domain. This is now
+ fixed.
+ <br>
+ (Giorgos Kourakos, Timo Heister, Wolfgang Bangerth, 2014/04/14)
+ </li>
+
<li> Changed: TableBase<N,T> now uses AlignedVector for storing data
instead of std::vector, which allows its use for VectorizedArray<Number>
data fields which require more alignment.
_end_allocated = _data + new_size;
if (_end_data != _data)
{
- internal::AlignedVectorMove<T>(new_data, new_data + old_size,
- _data);
+ dealii::internal::AlignedVectorMove<T>(new_data, new_data + old_size,
+ _data);
#if DEAL_II_COMPILER_VECTORIZATION_LEVEL > 0
_mm_free(new_data);
#else
// ---------------------------------------------------------------------
// $Id$
//
-// Copyright (C) 1999 - 2013 by the deal.II authors
+// Copyright (C) 1999 - 2014 by the deal.II authors
//
// This file is part of the deal.II library.
//
GridTools::delete_duplicated_vertices (vertices, cells,
subcell_data,
considered_vertices);
- GridReordering<dim,spacedim>::reorder_cells (cells);
-
result.clear ();
result.create_triangulation (vertices, cells, subcell_data);
}
// ---------------------------------------------------------------------
// $Id$
//
-// Copyright (C) 2001 - 2013 by the deal.II authors
+// Copyright (C) 2001 - 2014 by the deal.II authors
//
// This file is part of the deal.II library.
//
const Container<dim,spacedim> &container,
const Point<spacedim> &p)
{
- typedef typename Container<dim,spacedim>::active_cell_iterator cell_iterator;
+ typedef typename Container<dim,spacedim>::active_cell_iterator active_cell_iterator;
// The best distance is set to the
// maximum allowable distance from
// max. deviation of 1e-10
double best_distance = 1e-10;
int best_level = -1;
- std::pair<cell_iterator, Point<dim> > best_cell;
+ std::pair<active_cell_iterator, Point<dim> > best_cell;
// Find closest vertex and determine
// all adjacent cells
- unsigned int vertex = find_closest_vertex(container, p);
-
- std::vector<cell_iterator> adjacent_cells_tmp =
- find_cells_adjacent_to_vertex(container, vertex);
+ std::vector<active_cell_iterator> adjacent_cells_tmp
+ = find_cells_adjacent_to_vertex(container,
+ find_closest_vertex(container, p));
// Make sure that we have found
// at least one cell adjacent to vertex.
Assert(adjacent_cells_tmp.size()>0, ExcInternalError());
// Copy all the cells into a std::set
- std::set<cell_iterator> adjacent_cells(adjacent_cells_tmp.begin(), adjacent_cells_tmp.end());
- std::set<cell_iterator> searched_cells;
+ std::set<active_cell_iterator> adjacent_cells (adjacent_cells_tmp.begin(),
+ adjacent_cells_tmp.end());
+ std::set<active_cell_iterator> searched_cells;
// Determine the maximal number of cells
// in the grid.
// the cell and have not searched
// every cell in the triangulation,
// we keep on looking.
- const unsigned int n_cells =get_tria(container).n_cells();
+ const unsigned int n_active_cells = get_tria(container).n_active_cells();
bool found = false;
unsigned int cells_searched = 0;
- while (!found && cells_searched < n_cells)
+ while (!found && cells_searched < n_active_cells)
{
- typename std::set<cell_iterator>::const_iterator
+ typename std::set<active_cell_iterator>::const_iterator
cell = adjacent_cells.begin(),
endc = adjacent_cells.end();
for (; cell != endc; ++cell)
// unit cell (or at least not too far
// outside). If it is, it is also checked
// that the cell has a more refined state
- if (dist < best_distance ||
- (dist == best_distance && (*cell)->level() > best_level))
+ if ((dist < best_distance)
+ ||
+ ((dist == best_distance)
+ &&
+ ((*cell)->level() > best_level)))
{
- found = true;
+ found = true;
best_distance = dist;
best_level = (*cell)->level();
best_cell = std::make_pair(*cell, p_cell);
// to the next
}
}
- //udpate the number of cells searched
+
+ // update the number of cells searched
cells_searched += adjacent_cells.size();
+
// if we have not found the cell in
// question and have not yet searched every
// cell, we expand our search to
// all the not already searched neighbors of
// the cells in adjacent_cells. This is
- // what find_active_cell_around_poin_internal
+ // what find_active_cell_around_point_internal
// is for.
- if (!found && cells_searched < n_cells)
+ if (!found && cells_searched < n_active_cells)
{
find_active_cell_around_point_internal<dim,Container,spacedim>
(container, searched_cells, adjacent_cells);
DEAL::8 7 0.6152
DEAL::8 8 0.4102
DEAL::0 0 0.1406
-DEAL::0 1 -0.04688
+DEAL::0 1 -0.04687
DEAL::0 2 -0.04687
DEAL::0 3 0.01562
DEAL::0 4 0.2812
DEAL::2 8 0.7500
DEAL::3 0 -0.04688
DEAL::3 1 0.1406
-DEAL::3 2 0.01562
+DEAL::3 2 0.01563
DEAL::3 3 -0.04687
DEAL::3 4 -0.09375
DEAL::3 5 0.2812
DEAL::1 7 0
DEAL::1 8 1.000
DEAL::2 0 -0.04688
-DEAL::2 1 0.01562
+DEAL::2 1 0.01563
DEAL::2 2 0.1406
DEAL::2 3 -0.04687
DEAL::2 4 0.2813
DEAL::0 2 0.1406
DEAL::0 3 0.04688
DEAL::0 4 0.1406
-DEAL::0 5 0.04687
-DEAL::0 6 0.04687
+DEAL::0 5 0.04688
+DEAL::0 6 0.04688
DEAL::0 7 0.01562
DEAL::1 0 0.2813
DEAL::1 1 0.2812
DEAL::9 0 0.3281
DEAL::9 1 0.1094
DEAL::9 2 0.2344
-DEAL::9 3 0.07812
+DEAL::9 3 0.07813
DEAL::9 4 0.1094
DEAL::9 5 0.03646
DEAL::9 6 0.07812
DEAL::25 2 0.1094
DEAL::25 3 0.03646
DEAL::25 4 0.2344
-DEAL::25 5 0.07813
+DEAL::25 5 0.07812
DEAL::25 6 0.07812
DEAL::25 7 0.02604
DEAL::26 0 0.2500
DEAL::27 2 0.07292
DEAL::27 3 0.07292
DEAL::27 4 0.1563
-DEAL::27 5 0.1563
+DEAL::27 5 0.1562
DEAL::27 6 0.05208
DEAL::27 7 0.05208
DEAL::28 0 0.2500
DEAL::19 2 0.03125
DEAL::19 3 0.09375
DEAL::19 4 0.05208
-DEAL::19 5 0.1562
+DEAL::19 5 0.1563
DEAL::19 6 0.01042
DEAL::19 7 0.03125
DEAL::20 0 0.3125
DEAL::7 0 0.09375
DEAL::7 1 0.09375
DEAL::7 2 0.2813
-DEAL::7 3 0.2812
+DEAL::7 3 0.2813
DEAL::7 4 0.03125
DEAL::7 5 0.03125
DEAL::7 6 0.09375
DEAL::4 0 0.09375
DEAL::4 1 0.09375
DEAL::4 2 0.2813
-DEAL::4 3 0.2812
+DEAL::4 3 0.2813
DEAL::4 4 0.03125
DEAL::4 5 0.03125
DEAL::4 6 0.09375
DEAL::5 2 0.03125
DEAL::5 3 0.03125
DEAL::5 4 0.2813
-DEAL::5 5 0.2812
+DEAL::5 5 0.2813
DEAL::5 6 0.09375
DEAL::5 7 0.09375
DEAL::6 0 0.09375
DEAL::17 4 0.3281
DEAL::17 5 0.1094
DEAL::17 6 0.2344
-DEAL::17 7 0.07813
+DEAL::17 7 0.07812
DEAL::18 0 0.08333
DEAL::18 1 0.08333
DEAL::18 2 0.04167
DEAL::19 4 0.2188
DEAL::19 5 0.2188
DEAL::19 6 0.1563
-DEAL::19 7 0.1562
+DEAL::19 7 0.1563
DEAL::20 0 0.1250
DEAL::20 1 0.06250
DEAL::20 2 0.04167
DEAL::23 2 0.07292
DEAL::23 3 0.05208
DEAL::23 4 0.2188
-DEAL::23 5 0.1562
+DEAL::23 5 0.1563
DEAL::23 6 0.2188
DEAL::23 7 0.1563
DEAL::24 0 0.2344
DEAL::26 2 0.05208
DEAL::26 3 0.05208
DEAL::26 4 0.2188
-DEAL::26 5 0.2188
+DEAL::26 5 0.2187
DEAL::26 6 0.07292
DEAL::26 7 0.07292
DEAL::27 0 0.1250
DEAL::13 4 0.2188
DEAL::13 5 0.1562
DEAL::13 6 0.2188
-DEAL::13 7 0.1563
+DEAL::13 7 0.1562
DEAL::14 0 0.04167
DEAL::14 1 0.02083
DEAL::14 2 0.1250
DEAL::2 26 0
DEAL::3 0 -0.04688
DEAL::3 1 0.1406
-DEAL::3 2 0.01562
+DEAL::3 2 0.01563
DEAL::3 3 -0.04687
DEAL::3 4 0
DEAL::3 5 0
DEAL::5 1 0.1406
DEAL::5 2 0
DEAL::5 3 0
-DEAL::5 4 0.01562
+DEAL::5 4 0.01563
DEAL::5 5 -0.04687
DEAL::5 6 0
DEAL::5 7 0
DEAL::1 25 0
DEAL::1 26 0
DEAL::2 0 -0.04688
-DEAL::2 1 0.01562
+DEAL::2 1 0.01563
DEAL::2 2 0.1406
DEAL::2 3 -0.04687
DEAL::2 4 0
DEAL::7 3 0.1406
DEAL::7 4 0
DEAL::7 5 0
-DEAL::7 6 0.01562
+DEAL::7 6 0.01563
DEAL::7 7 -0.04687
DEAL::7 8 0
DEAL::7 9 0
DEAL::27 6 0.005208
DEAL::27 7 -0.01562
DEAL::27 8 -0.05208
-DEAL::27 9 0.1563
+DEAL::27 9 0.1562
DEAL::27 10 -0.05208
-DEAL::27 11 0.1563
+DEAL::27 11 0.1562
DEAL::27 12 0.01042
DEAL::27 13 -0.03125
DEAL::27 14 0.01042
DEAL::7 3 0
DEAL::7 4 -0.04688
DEAL::7 5 0.1406
-DEAL::7 6 0.01562
+DEAL::7 6 0.01563
DEAL::7 7 -0.04687
DEAL::7 8 0
DEAL::7 9 0
DEAL::11 11 0.01042
DEAL::11 12 -0.02604
DEAL::11 13 0.07812
-DEAL::11 14 0.1562
+DEAL::11 14 0.1563
DEAL::11 15 -0.03125
DEAL::11 16 -0.05208
DEAL::11 17 0.1563
DEAL::11 18 0.01042
DEAL::11 19 -0.03125
DEAL::11 20 -0.05208
-DEAL::11 21 0.1562
+DEAL::11 21 0.1563
DEAL::11 22 0.3125
DEAL::11 23 -0.06250
DEAL::11 24 -0.05208
-DEAL::11 25 0.1562
+DEAL::11 25 0.1563
DEAL::11 26 0.3125
DEAL::12 0 0.008681
DEAL::12 1 -0.01215
DEAL::3 20 0
DEAL::3 21 0
DEAL::3 22 -0.09375
-DEAL::3 23 0.2812
+DEAL::3 23 0.2813
DEAL::3 24 -0.09375
-DEAL::3 25 0.2812
+DEAL::3 25 0.2813
DEAL::3 26 0.5625
DEAL::4 0 0
DEAL::4 1 0
DEAL::6 2 0
DEAL::6 3 0
DEAL::6 4 -0.04688
-DEAL::6 5 0.01562
+DEAL::6 5 0.01563
DEAL::6 6 0.1406
DEAL::6 7 -0.04687
DEAL::6 8 0
DEAL::0 20 0
DEAL::0 21 0
DEAL::0 22 -0.09375
-DEAL::0 23 0.2812
+DEAL::0 23 0.2813
DEAL::0 24 -0.09375
DEAL::0 25 0.2812
DEAL::0 26 0.5625
DEAL::10 10 0.01042
DEAL::10 11 -0.05208
DEAL::10 12 -0.02604
-DEAL::10 13 0.07812
+DEAL::10 13 0.07813
DEAL::10 14 -0.03125
DEAL::10 15 0.1562
DEAL::10 16 0.01042
DEAL::0 0 0.0527344
DEAL::0 1 -0.0175781
DEAL::0 2 -0.0175781
-DEAL::0 3 0.00585938
+DEAL::0 3 0.00585937
DEAL::0 4 -0.0175781
-DEAL::0 5 0.00585938
+DEAL::0 5 0.00585937
DEAL::0 6 0.00585938
DEAL::0 7 -0.00195312
DEAL::0 8 0.105469
DEAL::0 10 0.105469
DEAL::0 11 -0.0351562
DEAL::0 12 -0.0351562
-DEAL::0 13 0.0117187
+DEAL::0 13 0.0117188
DEAL::0 14 -0.0351562
DEAL::0 15 0.0117188
DEAL::0 16 0.105469
DEAL::0 17 -0.0351562
DEAL::0 18 -0.0351562
-DEAL::0 19 0.0117188
+DEAL::0 19 0.0117187
DEAL::0 20 0.210938
DEAL::0 21 -0.0703125
DEAL::0 22 0.210938
DEAL::7 3 -0.0175781
DEAL::7 4 0.00585938
DEAL::7 5 -0.0175781
-DEAL::7 6 -0.00195313
+DEAL::7 6 -0.00195312
DEAL::7 7 0.00585937
DEAL::7 8 -0.0351563
DEAL::7 9 0.105469
DEAL::22 14 -0.0455729
DEAL::22 15 0.0151910
DEAL::22 16 -0.0195313
-DEAL::22 17 0.0273438
+DEAL::22 17 0.0273437
DEAL::22 18 0.00651042
DEAL::22 19 -0.00911458
DEAL::22 20 -0.0390625
DEAL::22 21 0.0546875
-DEAL::22 22 0.273437
+DEAL::22 22 0.273438
DEAL::22 23 -0.0911458
DEAL::22 24 0.273437
DEAL::22 25 -0.0911458
DEAL::16 17 0.00651042
DEAL::16 18 0.0273438
DEAL::16 19 -0.00911458
-DEAL::16 20 0.273437
+DEAL::16 20 0.273438
DEAL::16 21 -0.0911458
DEAL::16 22 -0.0390625
DEAL::16 23 0.0546875
DEAL::18 26 0.312500
DEAL::18 27 0
DEAL::19 0 0.00325521
-DEAL::19 1 -0.00976562
+DEAL::19 1 -0.00976563
DEAL::19 2 -0.0358073
DEAL::19 3 0.107422
DEAL::19 4 -0.00108507
DEAL::24 11 0.00651042
DEAL::24 12 0.0273437
DEAL::24 13 -0.00911458
-DEAL::24 14 0.0273437
+DEAL::24 14 0.0273438
DEAL::24 15 -0.00911458
DEAL::24 16 0.136719
DEAL::24 17 -0.0455729
DEAL::24 18 -0.0455729
DEAL::24 19 0.0151910
-DEAL::24 20 0.273437
+DEAL::24 20 0.273438
DEAL::24 21 -0.0911458
-DEAL::24 22 0.273437
+DEAL::24 22 0.273438
DEAL::24 23 -0.0911458
DEAL::24 24 -0.0390625
DEAL::24 25 0.0546875
DEAL::3 16 -0.0351563
DEAL::3 17 0.105469
DEAL::3 18 0.0117188
-DEAL::3 19 -0.0351563
+DEAL::3 19 -0.0351562
DEAL::3 20 -0.0703125
DEAL::3 21 0.210938
DEAL::3 22 0.210938
DEAL::10 16 -0.0716146
DEAL::10 17 0.214844
DEAL::10 18 0.00651042
-DEAL::10 19 -0.0195313
+DEAL::10 19 -0.0195312
DEAL::10 20 -0.0286458
DEAL::10 21 0.0859375
DEAL::10 22 0.429688
DEAL::8 12 0.136719
DEAL::8 13 -0.0455729
DEAL::8 14 -0.0195313
-DEAL::8 15 0.0273438
+DEAL::8 15 0.0273437
DEAL::8 16 -0.0195313
DEAL::8 17 0.00651042
DEAL::8 18 0.0273438
DEAL::11 2 0.0119358
DEAL::11 3 -0.0358073
DEAL::11 4 0.00325521
-DEAL::11 5 -0.00976563
+DEAL::11 5 -0.00976562
DEAL::11 6 -0.0358073
DEAL::11 7 0.107422
DEAL::11 8 0.00477431
DEAL::12 22 -0.0911458
DEAL::12 23 0.273438
DEAL::12 24 -0.0911458
-DEAL::12 25 0.273437
+DEAL::12 25 0.273438
DEAL::12 26 0.546875
DEAL::12 27 0
DEAL::13 0 -0.00173611
// ---------------------------------------------------------------------
// $Id$
//
-// Copyright (C) 2005 - 2013 by the deal.II authors
+// Copyright (C) 2005 - 2014 by the deal.II authors
//
// This file is part of the deal.II library.
//
LA.Tvmult(u, v2);
u *= -1;
A.Tvmult_add(u, v2);
- if (u.l2_norm() < 1.e-12)
+ if (u.l2_norm() < 1.e-11)
deallog << "Tvmult ok" << std::endl;
else
deallog << "Tvmult error " << u.l2_norm() << std::endl;
A.Tvmult(u, v2);
u *= -1;
LA.Tvmult_add(u, v2);
- if (u.l2_norm() < 1.e-12)
+ if (u.l2_norm() < 1.e-11)
deallog << "Tvmult_add ok" << std::endl;
else
deallog << "Tvmult_add error " << u.l2_norm() << std::endl;
// ---------------------------------------------------------------------
// $Id: 2d_refinement_01.cc 31349 2013-10-20 19:07:06Z maier $
//
-// Copyright (C) 2008 - 2013 by the deal.II authors
+// Copyright (C) 2008 - 2014 by the deal.II authors
//
// This file is part of the deal.II library.
//
#include <fstream>
#include <deal.II/fe/fe_q.h>
-template <int dim, int spacedim=dim>
+template <int dim, int spacedim>
void write_vtk (const parallel::distributed::Triangulation<dim,spacedim> &tria,
const char *filename)
{
GridGenerator::torus(tr, 1, 0.2);
tr.refine_global();
-
+
tr.begin_active()->set_refine_flag();
(++(tr.begin_active()))->set_refine_flag();
MPILogInitAll init;
deallog.push("2-3");
- test<2,3>(deallog.get_file_stream());
+ test<2,3>(deallog.get_file_stream());
deallog.pop();
}
DEAL::Size 32 Unknowns 961
DEAL::Solver type: N6dealii14SolverBicgstabINS_13PETScWrappers6VectorEEE
DEAL:Bicgstab::Starting value 31.00
-DEAL:Bicgstab::Convergence step 50 value 0
-DEAL::Solver stopped after 50 iterations
+DEAL:Bicgstab::Convergence step 49 value 0
+DEAL::Solver stopped after 49 iterations
DEAL::Size 32 Unknowns 961
DEAL::Solver type: N6dealii13PETScWrappers10SolverLSQRE
DEAL::Starting value 31.00
-DEAL::Failure step 100 value 24.02
+DEAL::Failure step 100 value 24.01
DEAL::Catched exception dealii::SolverControl::NoConvergence
DEAL::Solver stopped after 100 iterations
DEAL::Size 32 Unknowns 961
DEAL::Solver type: N6dealii14SolverBicgstabINS_16TrilinosWrappers6VectorEEE
DEAL:Bicgstab::Starting value 31.00
-DEAL:Bicgstab::Convergence step 50 value 0
-DEAL::Solver stopped after 50 iterations
+DEAL:Bicgstab::Convergence step 51 value 0
+DEAL::Solver stopped after 51 iterations