]>
https://gitweb.dealii.org/ - dealii.git/log
Timo Heister [Wed, 8 Jul 2020 20:02:15 +0000 (16:02 -0400)]
extract TBB colored WorkStream::run
Timo Heister [Wed, 8 Jul 2020 15:07:45 +0000 (11:07 -0400)]
add test
Timo Heister [Wed, 8 Jul 2020 14:15:03 +0000 (10:15 -0400)]
fix colored sequential code
Timo Heister [Tue, 7 Jul 2020 17:51:39 +0000 (13:51 -0400)]
reshuffle namespaces in workstream class
No big change in functionality, but needed for the transition to
taskflow:
- extract the TBB implementation into a separate namespace
- extract the sequential version
- sequential version caches empty worker/copier check
- add a few comments
part of #10391
David Wells [Tue, 7 Jul 2020 16:37:50 +0000 (12:37 -0400)]
Merge pull request #10613 from tjhei/cleanup_cmake_doxygen_message
cleanup a confusing cmake doxygen message
David Wells [Tue, 7 Jul 2020 15:48:37 +0000 (11:48 -0400)]
Merge pull request #10662 from masterleinad/deprecations_2
Remove more deprecations
David Wells [Tue, 7 Jul 2020 15:35:53 +0000 (11:35 -0400)]
Merge pull request #10630 from luca-heltai/bbox-transformations
Added unit_to_real and real_to_unit to BoundingBox
Timo Heister [Fri, 26 Jun 2020 21:01:11 +0000 (17:01 -0400)]
cleanup a confusing cmake doxygen message
David Wells [Tue, 7 Jul 2020 15:02:04 +0000 (11:02 -0400)]
Merge pull request #10253 from drwells/fix-doxygen-underscores
Fix doxygen underscores.
David Wells [Tue, 7 Jul 2020 14:44:50 +0000 (10:44 -0400)]
Merge pull request #10622 from masterleinad/remove_tecplot_binary
Remove deprecated DataOutBase::tecplot_binary
David Wells [Tue, 7 Jul 2020 14:42:23 +0000 (10:42 -0400)]
Merge pull request #10635 from peterrum/line_orientation_general
Generalize line_orientation() for 2D general meshes
Daniel Arndt [Tue, 7 Jul 2020 12:44:55 +0000 (08:44 -0400)]
Merge pull request #10651 from marcfehling/unification-without-domination
Bugfix: Unify dof indices on ghost interfaces if no finite element dominates.
Timo Heister [Tue, 7 Jul 2020 12:13:27 +0000 (08:13 -0400)]
Merge pull request #10664 from peterrum/step12_consts
Add some consts in step-12
Peter Munch [Tue, 7 Jul 2020 08:27:12 +0000 (10:27 +0200)]
Add some consts in step-12
Peter Munch [Tue, 7 Jul 2020 06:13:04 +0000 (08:13 +0200)]
Merge pull request #10663 from bangerth/doc-99
Add warnings to functions that set particle properties.
Wolfgang Bangerth [Tue, 7 Jul 2020 03:39:04 +0000 (21:39 -0600)]
Add warnings to functions that set particle properties.
Daniel Arndt [Tue, 7 Jul 2020 02:46:46 +0000 (22:46 -0400)]
Remove numbers::invalid_manifold_id
Daniel Arndt [Mon, 6 Jul 2020 20:36:37 +0000 (16:36 -0400)]
Remove MGConstrainedDoFs::get_level_constraint_matrix
Daniel Arndt [Mon, 6 Jul 2020 20:34:42 +0000 (16:34 -0400)]
Remove ResidualSimple::initialize_local_blocks
Peter Munch [Mon, 6 Jul 2020 19:39:56 +0000 (21:39 +0200)]
Merge pull request #10636 from masterleinad/remove_template_constraints
Remove constraint_and_return_value and types_are_equal
Peter Munch [Mon, 6 Jul 2020 19:32:15 +0000 (21:32 +0200)]
Merge pull request #10647 from masterleinad/fix_default_vector_tools_boundary
Fix default mapping parameter in VectorTools boundary functions
Peter Munch [Mon, 6 Jul 2020 19:26:09 +0000 (21:26 +0200)]
Merge pull request #10654 from masterleinad/remove_transpose_table_iterators
Remove deprecated TransposeTableIterators
Peter Munch [Mon, 6 Jul 2020 19:25:36 +0000 (21:25 +0200)]
Merge pull request #10655 from masterleinad/more_deprecatiosn
Remove more deprecations
Daniel Arndt [Mon, 6 Jul 2020 16:09:19 +0000 (12:09 -0400)]
Merge pull request #10658 from tjhei/taskflow-warning-fix
fix warning in bundled taskflow
Daniel Arndt [Mon, 6 Jul 2020 14:39:37 +0000 (10:39 -0400)]
Merge pull request #10657 from dangars/step_50_mpi_communicator
Replace MPI_COMM_WORLD by mpi_communicator in step-50
Timo Heister [Mon, 6 Jul 2020 14:30:59 +0000 (10:30 -0400)]
fix warning in bundled taskflow
fixes ``warning: extra ‘;’ [-Wpedantic]``
Daniel Garcia-Sanchez [Mon, 6 Jul 2020 08:01:43 +0000 (10:01 +0200)]
Replace MPI_COMM_WORLD by mpi_communicator
Daniel Arndt [Mon, 6 Jul 2020 02:29:29 +0000 (22:29 -0400)]
Remove PointValueHostory::get_point
Daniel Arndt [Mon, 6 Jul 2020 00:01:20 +0000 (20:01 -0400)]
Remove Solver
Daniel Arndt [Sun, 5 Jul 2020 22:09:07 +0000 (18:09 -0400)]
Remove deprecated CutOffFunctioNbase member functions
Daniel Arndt [Sun, 5 Jul 2020 16:18:57 +0000 (12:18 -0400)]
Remove deprecated TransposeTableIterators
Peter Munch [Sat, 4 Jul 2020 17:58:34 +0000 (19:58 +0200)]
Merge pull request #10640 from tamiko/step-69-references
examples/step-69: Link in repository for higher-order code
Timo Heister [Sat, 4 Jul 2020 12:24:28 +0000 (08:24 -0400)]
Merge pull request #10643 from peterrum/simplex_quadrature
Add additional quadrature rule for Simplex
Marc Fehling [Fri, 3 Jul 2020 14:48:05 +0000 (16:48 +0200)]
Bugfix: Unify dof indices on ghost interfaces if no finite element dominates.
By design, there will be always one dominating element for vertices.
Peter Munch [Thu, 2 Jul 2020 09:29:29 +0000 (11:29 +0200)]
Add additional quadrature rule for Simplex
Daniel Arndt [Thu, 2 Jul 2020 19:45:42 +0000 (15:45 -0400)]
Merge pull request #10644 from peterrum/inline_remove
Remve some inlines in tria_accessor.h
Peter Munch [Thu, 2 Jul 2020 17:44:59 +0000 (19:44 +0200)]
Merge pull request #10648 from masterleinad/remove_li_gdm_gdr
Remove LocalIntegrators::grad_div_matrix and LocalIntegrators::grad_div_residual
Daniel Arndt [Thu, 2 Jul 2020 14:01:53 +0000 (10:01 -0400)]
Remove LocalIntegrators::grad_div_matrix and LocalIntegrators::grad_div_residual
Daniel Arndt [Thu, 2 Jul 2020 13:49:28 +0000 (09:49 -0400)]
Fix default mapping parameter in VectorTools boundary functions
Peter Munch [Thu, 2 Jul 2020 10:48:08 +0000 (12:48 +0200)]
Remve some inlines in tria_accessor.h
Timo Heister [Wed, 1 Jul 2020 00:45:14 +0000 (20:45 -0400)]
Merge pull request #10611 from masterleinad/archive_documentation
Archive documentation
Matthias Maier [Tue, 30 Jun 2020 20:44:02 +0000 (15:44 -0500)]
examples/step-69: Link in repository for higher-order code
Luca Heltai [Tue, 30 Jun 2020 19:03:22 +0000 (21:03 +0200)]
Merge pull request #10629 from masterleinad/print_cmake_error_examples
Don't suppress error output from FIND_PACKAGE(deal.II ...) in examples
Peter Munch [Tue, 30 Jun 2020 18:02:47 +0000 (20:02 +0200)]
Generalize line_orientation() for 2D general meshes
Daniel Arndt [Tue, 30 Jun 2020 17:01:25 +0000 (13:01 -0400)]
Remove constraint_and_return_value and types_are_equal
Martin Kronbichler [Tue, 30 Jun 2020 06:44:05 +0000 (08:44 +0200)]
Merge pull request #10624 from masterleinad/suppres_tbb_warnings
Suppress TBB deprecation warnings
Martin Kronbichler [Tue, 30 Jun 2020 06:41:09 +0000 (08:41 +0200)]
Merge pull request #10625 from masterleinad/remove_prepare_serialization
Remove deprecated parallel::distributed::SolutionTransfer::prepare_serialization()
Martin Kronbichler [Tue, 30 Jun 2020 06:39:35 +0000 (08:39 +0200)]
Merge pull request #10634 from masterleinad/remove_deprecated_fgmres_additionaldata
Remove deprecated SolverFGMRES::AdditionalData constructor
Daniel Arndt [Tue, 30 Jun 2020 02:16:50 +0000 (22:16 -0400)]
Remove deprecated SolverFGMRES::AdditionalData constructor
Daniel Arndt [Tue, 30 Jun 2020 02:17:48 +0000 (22:17 -0400)]
Merge pull request #10626 from peterrum/files_dofhandlertype
Daniel Arndt [Tue, 30 Jun 2020 02:17:39 +0000 (22:17 -0400)]
Merge pull request #10632 from peterrum/arrayview_std_array
Enable ArrayView for std::array
Wolfgang Bangerth [Mon, 29 Jun 2020 23:13:24 +0000 (01:13 +0200)]
Merge pull request #10633 from peterrum/log_taskflow
Fix in log: cpp-taskflow -> taskflow
Peter Munch [Mon, 29 Jun 2020 22:49:14 +0000 (00:49 +0200)]
Fix in log: cpp-taskflow -> taskflow
Peter Munch [Mon, 29 Jun 2020 22:16:10 +0000 (00:16 +0200)]
Enable ArrayView for std::array
Wolfgang Bangerth [Mon, 29 Jun 2020 18:37:52 +0000 (20:37 +0200)]
Merge pull request #10627 from peterrum/iterators_dofhandlertype
Remove DoFHandlerType from internal::DoFHandlerImplementation::Iterators
Peter Munch [Mon, 29 Jun 2020 07:48:36 +0000 (09:48 +0200)]
Remove DoFHandlerType from internal::DoFHandlerImplementation::Iterators
Luca Heltai [Mon, 29 Jun 2020 12:52:46 +0000 (14:52 +0200)]
Added unit_to_real and real_to_unit to BoundingBox
Daniel Arndt [Mon, 29 Jun 2020 12:44:03 +0000 (08:44 -0400)]
Don't suppress error output from FIND_PACKAGE(deal.II ...) in examples
Peter Munch [Mon, 29 Jun 2020 07:31:28 +0000 (09:31 +0200)]
Remove DoFHandlerType from sparse_matrix_collection.h
Martin Kronbichler [Mon, 29 Jun 2020 07:12:15 +0000 (09:12 +0200)]
Merge pull request #10619 from peterrum/orientation_switch_bits
Switch flip and rotation bit in quad orientation
Peter Munch [Mon, 29 Jun 2020 06:57:55 +0000 (08:57 +0200)]
Remove DoFHandlerType from mg_tools.h
Peter Munch [Mon, 29 Jun 2020 06:50:20 +0000 (08:50 +0200)]
Remove DoFHandlerType from fe_tools.h
Peter Munch [Mon, 29 Jun 2020 06:40:29 +0000 (08:40 +0200)]
Remove DoFHandlerType from grid_tools.h and trilinos_precondition.h
Daniel Arndt [Mon, 29 Jun 2020 03:51:23 +0000 (23:51 -0400)]
Merge pull request #10532 from jppelteret/cmake_blacklist_appleclang_01
Daniel Arndt [Sun, 28 Jun 2020 22:03:31 +0000 (18:03 -0400)]
Fix indentation
Daniel Arndt [Sun, 28 Jun 2020 21:59:26 +0000 (17:59 -0400)]
Merge pull request #10618 from peterrum/tet_to_simplex
Rename TET to simplex
Daniel Arndt [Sun, 28 Jun 2020 21:51:32 +0000 (17:51 -0400)]
Remove deprecated parallel::distributed::SolutionTransfer::prepare_serialization()
Peter Munch [Sat, 27 Jun 2020 10:18:50 +0000 (12:18 +0200)]
Rename TET to simplex
Daniel Arndt [Sun, 28 Jun 2020 15:03:09 +0000 (11:03 -0400)]
Suppress TBB deprecation warnings
Daniel Arndt [Sun, 28 Jun 2020 12:55:12 +0000 (08:55 -0400)]
Merge pull request #10623 from masterleinad/remove_compare_for_face_domination
Remove deprecated FiniteElement::compare_for_face_domination and FECollection::find_least_face_dominating_fe
Martin Kronbichler [Sun, 28 Jun 2020 06:32:17 +0000 (08:32 +0200)]
Merge pull request #10617 from peterrum/matrix_creator_remove_dofhandlertype
Remove DoFHandlerType from numerics/matrix_creator
Martin Kronbichler [Sun, 28 Jun 2020 06:31:16 +0000 (08:31 +0200)]
Merge pull request #10615 from masterleinad/remove_default_quadrature
Remove Manifolds::get_default_quadrature
Daniel Arndt [Sun, 28 Jun 2020 03:05:32 +0000 (23:05 -0400)]
Remove deprecated FiniteElement::compare_for_face_domination and FECollection::find_least_face_dominating_fe
Daniel Arndt [Sun, 28 Jun 2020 01:58:24 +0000 (21:58 -0400)]
Remove deprecated DataOutBase::tecplot_binary
David Wells [Sat, 27 Jun 2020 14:28:27 +0000 (10:28 -0400)]
Merge pull request #10608 from peterrum/dof_tools_dofhandlertype
Remove DoFHandlerType from dofs/dof_tools
David Wells [Sat, 27 Jun 2020 14:27:21 +0000 (10:27 -0400)]
Merge pull request #10620 from bangerth/tensor
Introduce a new constructor for Tensor.
Wolfgang Bangerth [Sat, 27 Jun 2020 12:38:46 +0000 (14:38 +0200)]
Merge pull request #10616 from peterrum/IteratorRange_remove
Remove unused internal class
Wolfgang Bangerth [Sat, 27 Jun 2020 12:31:43 +0000 (06:31 -0600)]
Add a changelog entry.
Wolfgang Bangerth [Sat, 27 Jun 2020 12:29:53 +0000 (06:29 -0600)]
Add a test.
Wolfgang Bangerth [Fri, 26 Jun 2020 23:54:03 +0000 (17:54 -0600)]
Introduce a new constructor for Tensor.
Peter Munch [Sat, 27 Jun 2020 10:22:22 +0000 (12:22 +0200)]
Switch flip and rotation bit in quad orientation
Peter Munch [Sat, 27 Jun 2020 07:08:27 +0000 (09:08 +0200)]
Remove DoFHandlerType from numerics/matrix_creator
Peter Munch [Sat, 27 Jun 2020 06:42:31 +0000 (08:42 +0200)]
Remove unused internal class
Daniel Arndt [Sat, 27 Jun 2020 01:07:19 +0000 (21:07 -0400)]
Remove Manifolds::get_default_quadrature
Daniel Arndt [Fri, 26 Jun 2020 21:04:31 +0000 (17:04 -0400)]
Merge pull request #10610 from masterleinad/remove_get_fe_from_name
Daniel Arndt [Fri, 26 Jun 2020 21:03:31 +0000 (17:03 -0400)]
Merge pull request #10612 from kronbichler/fix-warning
Avoid warning of unused variable in release mode
Martin Kronbichler [Fri, 26 Jun 2020 20:10:09 +0000 (22:10 +0200)]
Merge pull request #10595 from bangerth/doc
Augment documentation of project_onto_orthogonal_tensors().
Martin Kronbichler [Fri, 26 Jun 2020 19:08:00 +0000 (21:08 +0200)]
Avoid warning of unused variable in release mode
Daniel Arndt [Fri, 26 Jun 2020 16:57:41 +0000 (12:57 -0400)]
Archive documentation
Martin Kronbichler [Fri, 26 Jun 2020 16:23:55 +0000 (18:23 +0200)]
Merge pull request #10609 from peterrum/vector_tools_dofhandlertype
Remove DoFHandlerType from numerics/vector_tools
Wolfgang Bangerth [Wed, 24 Jun 2020 17:20:25 +0000 (11:20 -0600)]
Augment documentation of project_onto_orthogonal_tensors().
Daniel Arndt [Fri, 26 Jun 2020 13:25:51 +0000 (09:25 -0400)]
Allow FE_NedelecSZ to be used in FETools::get_fe_by_name
Daniel Arndt [Fri, 26 Jun 2020 13:25:06 +0000 (09:25 -0400)]
Remove FETools::get_fe_from_name
Peter Munch [Fri, 26 Jun 2020 07:22:14 +0000 (09:22 +0200)]
Remove DoFHandlerType from numerics/vector_tools
Peter Munch [Fri, 26 Jun 2020 07:09:34 +0000 (09:09 +0200)]
Remove DoFHandlerType from dofs/dof_tools
Martin Kronbichler [Fri, 26 Jun 2020 07:24:35 +0000 (09:24 +0200)]
Merge pull request #10605 from dougshidong/solver_vector_documentation
Update solver Vector documentation.
Martin Kronbichler [Fri, 26 Jun 2020 07:08:01 +0000 (09:08 +0200)]
Merge pull request #10607 from bangerth/ref
Fix a reference entry.
Wolfgang Bangerth [Fri, 26 Jun 2020 03:09:35 +0000 (21:09 -0600)]
Fix a reference entry.
Doug Shi-Dong [Thu, 25 Jun 2020 23:18:22 +0000 (19:18 -0400)]
Update solver Vector documentation.
Requires 2 more function definition for GMRES and PreconditionIdentity.
Vector & operator = (const double a)
Vector & operator = (const Vector &x)
See https://github.com/dealii/dealii/blob/
301fce157e88add9a6a41e307d7cc5767b679cf1 /include/deal.II/lac/solver_gmres.h#L1013
See https://github.com/dealii/dealii/blob/
301fce157e88add9a6a41e307d7cc5767b679cf1 /include/deal.II/lac/precondition.h#L1273
David Wells [Thu, 25 Jun 2020 15:34:16 +0000 (11:34 -0400)]
Merge pull request #10603 from masterleinad/remove_deprecated_mf
Remove deprecated MatrixFree functions
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.