]> https://gitweb.dealii.org/ - dealii-svn.git/log
dealii-svn.git
11 years agoUse a void* in the argument list of MatShellGetContext as required by the compiler.
bangerth [Tue, 25 Sep 2012 12:32:14 +0000 (12:32 +0000)]
Use a void* in the argument list of MatShellGetContext as required by the compiler.

git-svn-id: https://svn.dealii.org/trunk@26719 0785d39b-7218-0410-832d-ea1e28bc413d

11 years agoFix branch marker that was erroneously merged.
bangerth [Tue, 25 Sep 2012 03:17:57 +0000 (03:17 +0000)]
Fix branch marker that was erroneously merged.

git-svn-id: https://svn.dealii.org/trunk@26701 0785d39b-7218-0410-832d-ea1e28bc413d

11 years agoMerge branch_component_mask into mainline.
bangerth [Tue, 25 Sep 2012 03:04:45 +0000 (03:04 +0000)]
Merge branch_component_mask into mainline.

git-svn-id: https://svn.dealii.org/trunk@26700 0785d39b-7218-0410-832d-ea1e28bc413d

11 years agoremove unused variable
heister [Mon, 24 Sep 2012 22:03:38 +0000 (22:03 +0000)]
remove unused variable

git-svn-id: https://svn.dealii.org/trunk@26692 0785d39b-7218-0410-832d-ea1e28bc413d

11 years agoInterface to MatShell matrix-type in PETSc
steigemann [Mon, 24 Sep 2012 21:57:25 +0000 (21:57 +0000)]
Interface to MatShell matrix-type in PETSc

git-svn-id: https://svn.dealii.org/trunk@26691 0785d39b-7218-0410-832d-ea1e28bc413d

11 years agoremove compiler warning
heister [Mon, 24 Sep 2012 21:52:45 +0000 (21:52 +0000)]
remove compiler warning

git-svn-id: https://svn.dealii.org/trunk@26690 0785d39b-7218-0410-832d-ea1e28bc413d

11 years agoInterface to MatShell matrix-type in PETSc
steigemann [Mon, 24 Sep 2012 21:44:07 +0000 (21:44 +0000)]
Interface to MatShell matrix-type in PETSc

git-svn-id: https://svn.dealii.org/trunk@26689 0785d39b-7218-0410-832d-ea1e28bc413d

11 years ago//---------------------------------------------------------------------------
steigemann [Mon, 24 Sep 2012 20:43:44 +0000 (20:43 +0000)]
//---------------------------------------------------------------------------
//    $Id: petsc_matrix_free.cc 26043 2012-09-24 19:25:57Z steigemann $
//    Version: $Name$
//
//    Copyright (C) 2012 by the deal.II authors
//
//    This file is subject to QPL and may not be  distributed
//    without copyright and license information. Please refer
//    to the file deal.II/doc/license.html for the  text  and
//    further information on this license.
//
//---------------------------------------------------------------------------

#include <deal.II/lac/petsc_matrix_free.h>

#ifdef DEAL_II_USE_PETSC

DEAL_II_NAMESPACE_OPEN

namespace PETScWrappers
{
  MatrixFree::MatrixFree ()
            : communicator (PETSC_COMM_SELF)
  {
    const int m=0;
    do_reinit (m, m, m, m);
  }

  MatrixFree::MatrixFree (const MPI_Comm     &communicator,
                          const unsigned int  m,
                          const unsigned int  n,
                          const unsigned int  local_rows,
                          const unsigned int  local_columns)
            : communicator (communicator)
  {
    do_reinit (m, n, local_rows, local_columns);
  }

  MatrixFree::MatrixFree (const MPI_Comm     &communicator,
                          const unsigned int  m,
                          const unsigned int  n,
                          const std::vector<unsigned int> &local_rows_per_process,
                          const std::vector<unsigned int> &local_columns_per_process,
                          const unsigned int  this_process)
            : communicator (communicator)
  {
    Assert (local_rows_per_process.size() == local_columns_per_process.size(),
            ExcDimensionMismatch (local_rows_per_process.size(),
                                  local_columns_per_process.size()));
    Assert (this_process < local_rows_per_process.size(),
            ExcInternalError());

    do_reinit (m, n,
               local_rows_per_process[this_process],
               local_columns_per_process[this_process]);
  }

  MatrixFree::MatrixFree (const unsigned int  m,
                          const unsigned int  n,
                          const unsigned int  local_rows,
                          const unsigned int  local_columns)
            : communicator (MPI_COMM_WORLD)
  {
    do_reinit (m, n, local_rows, local_columns);
  }

  MatrixFree::MatrixFree (const unsigned int  m,
                          const unsigned int  n,
                          const std::vector<unsigned int> &local_rows_per_process,
                          const std::vector<unsigned int> &local_columns_per_process,
                          const unsigned int  this_process)
            : communicator (MPI_COMM_WORLD)
  {
    Assert (local_rows_per_process.size() == local_columns_per_process.size(),
            ExcDimensionMismatch (local_rows_per_process.size(),
                                  local_columns_per_process.size()));
    Assert (this_process < local_rows_per_process.size(),
            ExcInternalError());

    do_reinit (m, n,
               local_rows_per_process[this_process],
               local_columns_per_process[this_process]);
  }

  void MatrixFree::reinit (const MPI_Comm     &communicator,
                           const unsigned int  m,
                           const unsigned int  n,
                           const unsigned int  local_rows,
                           const unsigned int  local_columns)
  {
    this->communicator = communicator;

                                     // destroy the matrix and
                                     // generate a new one
#if DEAL_II_PETSC_VERSION_LT(3,2,0)
    int ierr = MatDestroy (matrix);
#else
    int ierr = MatDestroy (&matrix);
#endif
    AssertThrow (ierr == 0, ExcPETScError(ierr));

    do_reinit (m, n, local_rows, local_columns);
  }

  void MatrixFree::reinit (const MPI_Comm     &communicator,
                           const unsigned int  m,
                           const unsigned int  n,
                           const std::vector<unsigned int> &local_rows_per_process,
                           const std::vector<unsigned int> &local_columns_per_process,
                           const unsigned int  this_process)
  {
    Assert (local_rows_per_process.size() == local_columns_per_process.size(),
            ExcDimensionMismatch (local_rows_per_process.size(),
                                  local_columns_per_process.size()));
    Assert (this_process < local_rows_per_process.size(),
            ExcInternalError());

    this->communicator = communicator;

#if DEAL_II_PETSC_VERSION_LT(3,2,0)
    int ierr = MatDestroy (matrix);
#else
    int ierr = MatDestroy (&matrix);
#endif
    AssertThrow (ierr == 0, ExcPETScError(ierr));

    do_reinit (m, n,
               local_rows_per_process[this_process],
               local_columns_per_process[this_process]);
  }

  void MatrixFree::reinit (const unsigned int  m,
                           const unsigned int  n,
                           const unsigned int  local_rows,
                           const unsigned int  local_columns)
  {
    reinit (MPI_COMM_WORLD, m, n, local_rows, local_columns);
  }

  void MatrixFree::reinit (const unsigned int  m,
                           const unsigned int  n,
                           const std::vector<unsigned int> &local_rows_per_process,
                           const std::vector<unsigned int> &local_columns_per_process,
                           const unsigned int  this_process)
  {
    reinit (MPI_COMM_WORLD, m, n, local_rows_per_process, local_columns_per_process, this_process);
  }

  void MatrixFree::clear ()
  {
#if DEAL_II_PETSC_VERSION_LT(3,2,0)
    int ierr = MatDestroy (matrix);
#else
    int ierr = MatDestroy (&matrix);
#endif
    AssertThrow (ierr == 0, ExcPETScError(ierr));

    const int m=0;
    do_reinit (m, m, m, m);
  }

  void MatrixFree::vmult (Vec  &dst, const Vec  &src) const
  {

//TODO: Translate the given PETSc Vec* vector into a deal.II
// vector so we can call the vmult function with the usual
// interface; then convert back. This could be much more
// efficient, if the PETScWrappers::*::Vector classes
// had a way to simply generate such a vector object from
// a given PETSc Vec* object without allocating new memory
// and without taking ownership of the Vec*

    VectorBase  *x = 0;
    VectorBase  *y = 0;
                                     // because we do not know,
                                     // if dst and src are sequential
                                     // or distributed vectors,
                                     // we ask for the vector-type
                                     // and reinit x and y with
                                     // dealii::PETScWrappers::*::Vector:
    const char  *vec_type;
    int ierr = VecGetType (src, &vec_type);

    PetscInt  local_size;
    ierr = VecGetLocalSize (src, &local_size);
    AssertThrow (ierr == 0, ExcPETScError(ierr));

    if (strcmp(vec_type,"mpi") == 0)
      {
        PetscInt  size;
        ierr = VecGetSize (src, &size);
        AssertThrow (ierr == 0, ExcPETScError(ierr));

        x = new PETScWrappers::MPI::Vector (this->get_mpi_communicator (), size, local_size);
        y = new PETScWrappers::MPI::Vector (this->get_mpi_communicator (), size, local_size);
      }
    else if (strcmp(vec_type,"seq") == 0)
      {
        x = new PETScWrappers::Vector (local_size);
        y = new PETScWrappers::Vector (local_size);
      }
    else
      AssertThrow (false, ExcMessage("PETScWrappers::MPI::MatrixFree::do_matrix_vector_action: "
                                     "This only works for Petsc Vec Type = VECMPI | VECSEQ"));

                                     // copy src to x
    x->equ(1., PETScWrappers::VectorBase(src));
                                     // and call vmult(x,y) which must
                                     // be reimplemented in derived classes
    vmult (*y, *x);

    y->compress();
                                     // copy the result back to dst
    ierr = VecCopy (&(*(*y)), dst);
    AssertThrow (ierr == 0, ExcPETScError(ierr));

    delete (x);
    delete (y);
  }

  int MatrixFree::matrix_free_mult (Mat  A, Vec  src, Vec  dst)
  {
                                     // create a pointer to this MatrixFree
                                     // object and link the given matrix A
                                     // to the matrix-vector multiplication
                                     // of this MatrixFree object,
    MatrixFree  *this_object;
    int ierr = MatShellGetContext (A, &this_object);
    AssertThrow (ierr == 0, ExcPETScError(ierr));

                                     // call vmult of this object:
    this_object->vmult (dst, src);

    return (0);
  }

  void MatrixFree::do_reinit (const unsigned int  m,
                              const unsigned int  n,
                              const unsigned int  local_rows,
                              const unsigned int  local_columns)
  {
    Assert (local_rows <= m, ExcDimensionMismatch (local_rows, m));
    Assert (local_columns <= n, ExcDimensionMismatch (local_columns, n));

    int ierr;
                                     // create a PETSc MatShell matrix-type
                                     // object of dimension m x n and local size
                                     // local_rows x local_columns
    ierr = MatCreateShell(communicator, local_rows, local_columns, m, n, (void*)this, &matrix);
    AssertThrow (ierr == 0, ExcPETScError(ierr));
                                     // register the MatrixFree::matrix_free_mult function
                                     // as the matrix multiplication used by this matrix
    ierr = MatShellSetOperation (matrix, MATOP_MULT,
               (void(*)(void))&dealii::PETScWrappers::MatrixFree::matrix_free_mult);
    AssertThrow (ierr == 0, ExcPETScError(ierr));

    ierr = MatSetFromOptions (matrix);
    AssertThrow (ierr == 0, ExcPETScError(ierr));
  }
}

DEAL_II_NAMESPACE_CLOSE

#endif // DEAL_II_USE_PETSC

git-svn-id: https://svn.dealii.org/trunk@26688 0785d39b-7218-0410-832d-ea1e28bc413d

11 years agofix typo in docu
heister [Mon, 24 Sep 2012 17:45:27 +0000 (17:45 +0000)]
fix typo in docu

git-svn-id: https://svn.dealii.org/trunk@26676 0785d39b-7218-0410-832d-ea1e28bc413d

11 years agomake constructor of IndexSet explicit
heister [Mon, 24 Sep 2012 15:40:45 +0000 (15:40 +0000)]
make constructor of IndexSet explicit

git-svn-id: https://svn.dealii.org/trunk@26668 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoFix bad markup.
bangerth [Sun, 23 Sep 2012 14:43:19 +0000 (14:43 +0000)]
Fix bad markup.

git-svn-id: https://svn.dealii.org/trunk@26643 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoFix a typo.
bangerth [Sat, 22 Sep 2012 00:25:32 +0000 (00:25 +0000)]
Fix a typo.

git-svn-id: https://svn.dealii.org/trunk@26621 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agokeywords?
kanschat [Fri, 21 Sep 2012 08:30:55 +0000 (08:30 +0000)]
keywords?

git-svn-id: https://svn.dealii.org/trunk@26583 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoexplain how to link documentation
kanschat [Fri, 21 Sep 2012 08:15:35 +0000 (08:15 +0000)]
explain how to link documentation

git-svn-id: https://svn.dealii.org/trunk@26582 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agomake namespace visible
kanschat [Fri, 21 Sep 2012 08:15:14 +0000 (08:15 +0000)]
make namespace visible

git-svn-id: https://svn.dealii.org/trunk@26581 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoNew tests.
bangerth [Thu, 20 Sep 2012 15:41:46 +0000 (15:41 +0000)]
New tests.

git-svn-id: https://svn.dealii.org/trunk@26572 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoPatch by Felix Gruber (felgru): Fix a number of typos and documentation problems.
bangerth [Thu, 20 Sep 2012 14:58:51 +0000 (14:58 +0000)]
Patch by Felix Gruber (felgru): Fix a number of typos and documentation problems.

git-svn-id: https://svn.dealii.org/trunk@26569 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoAugment documentation.
bangerth [Thu, 20 Sep 2012 14:08:13 +0000 (14:08 +0000)]
Augment documentation.

git-svn-id: https://svn.dealii.org/trunk@26568 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoNew test.
bangerth [Thu, 20 Sep 2012 14:03:34 +0000 (14:03 +0000)]
New test.

git-svn-id: https://svn.dealii.org/trunk@26567 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoNew test.
bangerth [Thu, 20 Sep 2012 13:59:37 +0000 (13:59 +0000)]
New test.

git-svn-id: https://svn.dealii.org/trunk@26566 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoAdd DoFRenumbering::block_wise functions.
bangerth [Thu, 20 Sep 2012 13:37:48 +0000 (13:37 +0000)]
Add DoFRenumbering::block_wise functions.

git-svn-id: https://svn.dealii.org/trunk@26565 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoAdd a FECollection::n_blocks function.
bangerth [Thu, 20 Sep 2012 13:37:12 +0000 (13:37 +0000)]
Add a FECollection::n_blocks function.

git-svn-id: https://svn.dealii.org/trunk@26564 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoNew test.
bangerth [Thu, 20 Sep 2012 13:36:06 +0000 (13:36 +0000)]
New test.

git-svn-id: https://svn.dealii.org/trunk@26563 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoFix typo.
bangerth [Thu, 20 Sep 2012 13:28:15 +0000 (13:28 +0000)]
Fix typo.

git-svn-id: https://svn.dealii.org/trunk@26562 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoGroup functions for doxygen.
bangerth [Thu, 20 Sep 2012 12:26:40 +0000 (12:26 +0000)]
Group functions for doxygen.

git-svn-id: https://svn.dealii.org/trunk@26561 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoadd elasticity example and highlight the differences between the
kanschat [Thu, 20 Sep 2012 12:07:16 +0000 (12:07 +0000)]
add elasticity example and highlight the differences between the
different approaches

git-svn-id: https://svn.dealii.org/trunk@26560 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoMake project_boundary_values_curl_conforming work for arbitrary FESystem.
buerg [Thu, 20 Sep 2012 09:20:12 +0000 (09:20 +0000)]
Make project_boundary_values_curl_conforming work for arbitrary FESystem.

git-svn-id: https://svn.dealii.org/trunk@26554 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoPatch by Felgru: Fix a bunch of documentation typos.
bangerth [Thu, 20 Sep 2012 03:00:21 +0000 (03:00 +0000)]
Patch by Felgru: Fix a bunch of documentation typos.

git-svn-id: https://svn.dealii.org/trunk@26543 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoGenerate output in GMV format instead of VTK. GMV has long been dead.
bangerth [Thu, 20 Sep 2012 02:42:11 +0000 (02:42 +0000)]
Generate output in GMV format instead of VTK. GMV has long been dead.

git-svn-id: https://svn.dealii.org/trunk@26542 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agofix last commit
heister [Wed, 19 Sep 2012 23:30:18 +0000 (23:30 +0000)]
fix last commit

git-svn-id: https://svn.dealii.org/trunk@26537 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agofix last commit
heister [Wed, 19 Sep 2012 23:29:41 +0000 (23:29 +0000)]
fix last commit

git-svn-id: https://svn.dealii.org/trunk@26536 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agobenchmark: tweak script
heister [Wed, 19 Sep 2012 23:27:37 +0000 (23:27 +0000)]
benchmark: tweak script

git-svn-id: https://svn.dealii.org/trunk@26535 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agobenchmark: update script and ignores
heister [Wed, 19 Sep 2012 23:14:49 +0000 (23:14 +0000)]
benchmark: update script and ignores

git-svn-id: https://svn.dealii.org/trunk@26534 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agowork on benchmark script
heister [Wed, 19 Sep 2012 22:35:38 +0000 (22:35 +0000)]
work on benchmark script

git-svn-id: https://svn.dealii.org/trunk@26533 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoperformance benchmark: move to a more reasonable starting revision
heister [Wed, 19 Sep 2012 22:11:25 +0000 (22:11 +0000)]
performance benchmark: move to a more reasonable starting revision

git-svn-id: https://svn.dealii.org/trunk@26531 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoadd a second performance test
heister [Wed, 19 Sep 2012 22:09:48 +0000 (22:09 +0000)]
add a second performance test

git-svn-id: https://svn.dealii.org/trunk@26530 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoperformance benchmark: clean the tests and write to different output files
heister [Wed, 19 Sep 2012 22:08:19 +0000 (22:08 +0000)]
performance benchmark: clean the tests and write to different output files

git-svn-id: https://svn.dealii.org/trunk@26529 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoUpdated benchmark test script
cazamias [Wed, 19 Sep 2012 21:42:19 +0000 (21:42 +0000)]
Updated benchmark test script

git-svn-id: https://svn.dealii.org/trunk@26528 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoupdate benchmark code to not require umfpack
heister [Wed, 19 Sep 2012 21:31:32 +0000 (21:31 +0000)]
update benchmark code to not require umfpack

git-svn-id: https://svn.dealii.org/trunk@26526 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoupdate svn:ignores
heister [Wed, 19 Sep 2012 21:29:18 +0000 (21:29 +0000)]
update svn:ignores

git-svn-id: https://svn.dealii.org/trunk@26525 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoedit script
heister [Wed, 19 Sep 2012 21:27:49 +0000 (21:27 +0000)]
edit script

git-svn-id: https://svn.dealii.org/trunk@26522 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoLink to DoFTools::make_periodicity_constraints().
bangerth [Wed, 19 Sep 2012 13:35:18 +0000 (13:35 +0000)]
Link to DoFTools::make_periodicity_constraints().

git-svn-id: https://svn.dealii.org/trunk@26507 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoFix missing include file.
bangerth [Tue, 18 Sep 2012 18:14:08 +0000 (18:14 +0000)]
Fix missing include file.

git-svn-id: https://svn.dealii.org/trunk@26477 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoUpdate output.
bangerth [Tue, 18 Sep 2012 16:29:50 +0000 (16:29 +0000)]
Update output.

git-svn-id: https://svn.dealii.org/trunk@26476 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoMake compile with current gcc mainline.
bangerth [Tue, 18 Sep 2012 14:43:39 +0000 (14:43 +0000)]
Make compile with current gcc mainline.

git-svn-id: https://svn.dealii.org/trunk@26474 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoFix a crash in TimerOutput when MPI hasn't been initialized.
bangerth [Tue, 18 Sep 2012 13:08:41 +0000 (13:08 +0000)]
Fix a crash in TimerOutput when MPI hasn't been initialized.

git-svn-id: https://svn.dealii.org/trunk@26473 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoAdd a book.
bangerth [Tue, 18 Sep 2012 02:26:18 +0000 (02:26 +0000)]
Add a book.

git-svn-id: https://svn.dealii.org/trunk@26464 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoFix a crash under rare circumstances at the end of a program.
bangerth [Tue, 18 Sep 2012 02:21:32 +0000 (02:21 +0000)]
Fix a crash under rare circumstances at the end of a program.

git-svn-id: https://svn.dealii.org/trunk@26463 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoupdate Makefile
heister [Mon, 17 Sep 2012 21:00:44 +0000 (21:00 +0000)]
update Makefile

git-svn-id: https://svn.dealii.org/trunk@26450 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoupdate ignores
heister [Mon, 17 Sep 2012 21:00:11 +0000 (21:00 +0000)]
update ignores

git-svn-id: https://svn.dealii.org/trunk@26448 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoadd timing stuff
heister [Mon, 17 Sep 2012 20:58:35 +0000 (20:58 +0000)]
add timing stuff

git-svn-id: https://svn.dealii.org/trunk@26447 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoadd failing test for TimerOutput
heister [Mon, 17 Sep 2012 20:53:30 +0000 (20:53 +0000)]
add failing test for TimerOutput

git-svn-id: https://svn.dealii.org/trunk@26446 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoupdate script
heister [Mon, 17 Sep 2012 20:37:50 +0000 (20:37 +0000)]
update script

git-svn-id: https://svn.dealii.org/trunk@26445 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoadd first skeleton for performance benchmark
heister [Mon, 17 Sep 2012 19:15:09 +0000 (19:15 +0000)]
add first skeleton for performance benchmark

git-svn-id: https://svn.dealii.org/trunk@26442 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoAdjust output after the recent fixes to TableHandler. The new output is correct as...
bangerth [Mon, 17 Sep 2012 16:07:15 +0000 (16:07 +0000)]
Adjust output after the recent fixes to TableHandler. The new output is correct as verified by base/table_handler_12.

git-svn-id: https://svn.dealii.org/trunk@26437 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoNew test.
bangerth [Mon, 17 Sep 2012 16:05:55 +0000 (16:05 +0000)]
New test.

git-svn-id: https://svn.dealii.org/trunk@26436 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoadd script for regression tester
heister [Mon, 17 Sep 2012 16:05:50 +0000 (16:05 +0000)]
add script for regression tester

git-svn-id: https://svn.dealii.org/trunk@26435 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agomove old benchmark tests away
heister [Mon, 17 Sep 2012 16:04:32 +0000 (16:04 +0000)]
move old benchmark tests away

git-svn-id: https://svn.dealii.org/trunk@26434 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoNew tests.
bangerth [Sun, 16 Sep 2012 22:16:36 +0000 (22:16 +0000)]
New tests.

git-svn-id: https://svn.dealii.org/trunk@26425 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoupdate output
heister [Sun, 16 Sep 2012 20:17:36 +0000 (20:17 +0000)]
update output

git-svn-id: https://svn.dealii.org/trunk@26423 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agofix serialization of TableHandler
heister [Sun, 16 Sep 2012 20:16:35 +0000 (20:16 +0000)]
fix serialization of TableHandler

git-svn-id: https://svn.dealii.org/trunk@26422 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agosimplify test
heister [Sun, 16 Sep 2012 20:07:47 +0000 (20:07 +0000)]
simplify test

git-svn-id: https://svn.dealii.org/trunk@26420 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agofix output
heister [Sun, 16 Sep 2012 19:57:23 +0000 (19:57 +0000)]
fix output

git-svn-id: https://svn.dealii.org/trunk@26419 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agofix output
heister [Sun, 16 Sep 2012 19:56:01 +0000 (19:56 +0000)]
fix output

git-svn-id: https://svn.dealii.org/trunk@26418 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agofix test output
heister [Sun, 16 Sep 2012 16:35:01 +0000 (16:35 +0000)]
fix test output

git-svn-id: https://svn.dealii.org/trunk@26411 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agofix test output
heister [Sun, 16 Sep 2012 16:33:11 +0000 (16:33 +0000)]
fix test output

git-svn-id: https://svn.dealii.org/trunk@26410 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agofix output of captions.
heister [Sun, 16 Sep 2012 16:32:49 +0000 (16:32 +0000)]
fix output of captions.

git-svn-id: https://svn.dealii.org/trunk@26409 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agofix test output
heister [Sun, 16 Sep 2012 16:25:04 +0000 (16:25 +0000)]
fix test output

git-svn-id: https://svn.dealii.org/trunk@26407 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoupdate test and output for treating super-columns
heister [Sun, 16 Sep 2012 16:21:44 +0000 (16:21 +0000)]
update test and output for treating super-columns

git-svn-id: https://svn.dealii.org/trunk@26406 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoconsistent output of super-columns in TableHandler::write_text()
heister [Sun, 16 Sep 2012 16:21:18 +0000 (16:21 +0000)]
consistent output of super-columns in TableHandler::write_text()

git-svn-id: https://svn.dealii.org/trunk@26405 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoadd test for supercolumn output in TableHandler
heister [Sun, 16 Sep 2012 16:14:51 +0000 (16:14 +0000)]
add test for supercolumn output in TableHandler

git-svn-id: https://svn.dealii.org/trunk@26404 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agofix output of captions.
heister [Sun, 16 Sep 2012 15:06:51 +0000 (15:06 +0000)]
fix output of captions.

git-svn-id: https://svn.dealii.org/trunk@26403 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoUpdate.
bangerth [Fri, 14 Sep 2012 21:57:16 +0000 (21:57 +0000)]
Update.

git-svn-id: https://svn.dealii.org/trunk@26396 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agospeed up TableHandler::write_text by caching the formatted lines.
heister [Fri, 14 Sep 2012 21:44:56 +0000 (21:44 +0000)]
speed up TableHandler::write_text by caching the formatted lines.

git-svn-id: https://svn.dealii.org/trunk@26394 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoadd failing test for deallog
heister [Fri, 14 Sep 2012 16:26:38 +0000 (16:26 +0000)]
add failing test for deallog

git-svn-id: https://svn.dealii.org/trunk@26388 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agofix output
heister [Fri, 14 Sep 2012 16:24:36 +0000 (16:24 +0000)]
fix output

git-svn-id: https://svn.dealii.org/trunk@26387 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agodisable auto-detection of hdf5 in configure
heister [Fri, 14 Sep 2012 16:22:31 +0000 (16:22 +0000)]
disable auto-detection of hdf5 in configure

git-svn-id: https://svn.dealii.org/trunk@26386 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoadd test for table handler
heister [Fri, 14 Sep 2012 16:06:25 +0000 (16:06 +0000)]
add test for table handler

git-svn-id: https://svn.dealii.org/trunk@26385 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoStep 4: Remove the original monster testcase. Hurray.
bangerth [Fri, 14 Sep 2012 12:58:32 +0000 (12:58 +0000)]
Step 4: Remove the original monster testcase. Hurray.

git-svn-id: https://svn.dealii.org/trunk@26379 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoStep 3: Also break out the computation of the prolongation matrices.
bangerth [Fri, 14 Sep 2012 12:58:04 +0000 (12:58 +0000)]
Step 3: Also break out the computation of the prolongation matrices.

git-svn-id: https://svn.dealii.org/trunk@26378 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoStep 2: break the restriction matrices out of the 'internals' test.
bangerth [Fri, 14 Sep 2012 12:53:49 +0000 (12:53 +0000)]
Step 2: break the restriction matrices out of the 'internals' test.

git-svn-id: https://svn.dealii.org/trunk@26377 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoStep one in breaking apart our monster testcase 'internals'. That testcase had an...
bangerth [Fri, 14 Sep 2012 12:32:17 +0000 (12:32 +0000)]
Step one in breaking apart our monster testcase 'internals'. That testcase had an output of over 6MB with more than 12000 lines, a good fraction of which is susceptible to round-off errors. It is time to split this testcase by finite element to be able to tell more easily what is going on. These new testcases take over the part where we test support points.

git-svn-id: https://svn.dealii.org/trunk@26376 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoExplicitly say so if a gmsh file being read contains triangles or tetrahedra.
bangerth [Fri, 14 Sep 2012 11:08:57 +0000 (11:08 +0000)]
Explicitly say so if a gmsh file being read contains triangles or tetrahedra.

git-svn-id: https://svn.dealii.org/trunk@26375 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoadd news
kanschat [Fri, 14 Sep 2012 08:39:51 +0000 (08:39 +0000)]
add news

git-svn-id: https://svn.dealii.org/trunk@26372 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoadd a simplified interface for MeshWorker::loop()
kanschat [Fri, 14 Sep 2012 08:37:12 +0000 (08:37 +0000)]
add a simplified interface for MeshWorker::loop()

git-svn-id: https://svn.dealii.org/trunk@26371 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoWait for processor 0 to be done with data files before deleting them.
bangerth [Thu, 13 Sep 2012 15:16:50 +0000 (15:16 +0000)]
Wait for processor 0 to be done with data files before deleting them.

git-svn-id: https://svn.dealii.org/trunk@26355 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoOnly delete tmp files created on the current processor.
bangerth [Thu, 13 Sep 2012 12:06:11 +0000 (12:06 +0000)]
Only delete tmp files created on the current processor.

git-svn-id: https://svn.dealii.org/trunk@26346 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoDelete tmp files again.
bangerth [Thu, 13 Sep 2012 01:43:34 +0000 (01:43 +0000)]
Delete tmp files again.

git-svn-id: https://svn.dealii.org/trunk@26333 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoAdjust whitespace change related to r26325.
bangerth [Thu, 13 Sep 2012 01:31:49 +0000 (01:31 +0000)]
Adjust whitespace change related to r26325.

git-svn-id: https://svn.dealii.org/trunk@26332 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoMinor edits related to using '\n' instead of std::endl.
bangerth [Wed, 12 Sep 2012 19:25:44 +0000 (19:25 +0000)]
Minor edits related to using '\n' instead of std::endl.

git-svn-id: https://svn.dealii.org/trunk@26325 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoremove specializations in TriaObjects
kanschat [Wed, 12 Sep 2012 15:26:51 +0000 (15:26 +0000)]
remove specializations in TriaObjects

git-svn-id: https://svn.dealii.org/trunk@26313 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoonly base class is required for initialization
kanschat [Wed, 12 Sep 2012 12:44:34 +0000 (12:44 +0000)]
only base class is required for initialization

git-svn-id: https://svn.dealii.org/trunk@26311 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agointroduce Hermite interpolation polynomials
kanschat [Wed, 12 Sep 2012 12:35:57 +0000 (12:35 +0000)]
introduce Hermite interpolation polynomials

git-svn-id: https://svn.dealii.org/trunk@26310 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoUpdate one.
bangerth [Wed, 12 Sep 2012 11:08:48 +0000 (11:08 +0000)]
Update one.

git-svn-id: https://svn.dealii.org/trunk@26304 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoMake project_boundary_values_curl_conforming work for distributed grids.
buerg [Wed, 12 Sep 2012 10:38:29 +0000 (10:38 +0000)]
Make project_boundary_values_curl_conforming work for distributed grids.

git-svn-id: https://svn.dealii.org/trunk@26303 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agotest Hermite interpolation polynomials
kanschat [Wed, 12 Sep 2012 08:59:34 +0000 (08:59 +0000)]
test Hermite interpolation polynomials

git-svn-id: https://svn.dealii.org/trunk@26300 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoavoid specializations
kanschat [Wed, 12 Sep 2012 08:13:09 +0000 (08:13 +0000)]
avoid specializations

git-svn-id: https://svn.dealii.org/trunk@26297 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoavoid specializations
kanschat [Wed, 12 Sep 2012 08:06:41 +0000 (08:06 +0000)]
avoid specializations

git-svn-id: https://svn.dealii.org/trunk@26296 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoAssume that std::numeric_limits is available. This has been the case for a very long...
bangerth [Tue, 11 Sep 2012 13:31:52 +0000 (13:31 +0000)]
Assume that std::numeric_limits is available. This has been the case for a very long time already.

git-svn-id: https://svn.dealii.org/trunk@26283 0785d39b-7218-0410-832d-ea1e28bc413d

12 years agoCompilers have had std::i/ostringstream for a long time. Remove alternative.
bangerth [Tue, 11 Sep 2012 13:13:13 +0000 (13:13 +0000)]
Compilers have had std::i/ostringstream for a long time. Remove alternative.

git-svn-id: https://svn.dealii.org/trunk@26281 0785d39b-7218-0410-832d-ea1e28bc413d


In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.