]>
https://gitweb.dealii.org/ - dealii.git/log
David Wells [Wed, 9 Jun 2021 20:07:26 +0000 (16:07 -0400)]
Improve comments.
David Wells [Wed, 9 Jun 2021 20:06:37 +0000 (16:06 -0400)]
Refer to the face type as such.
David Wells [Wed, 9 Jun 2021 20:05:10 +0000 (16:05 -0400)]
Add a utility function for next available vertices.
David Wells [Wed, 9 Jun 2021 20:02:46 +0000 (16:02 -0400)]
Un-hardcode some constants.
David Wells [Wed, 9 Jun 2021 23:53:17 +0000 (19:53 -0400)]
Merge pull request #12427 from drwells/add-AssertIsNotUsed
Add an assertion for unused tria objects.
David Wells [Wed, 9 Jun 2021 19:40:27 +0000 (15:40 -0400)]
Add an assertion for unused tria objects.
David Wells [Wed, 9 Jun 2021 19:08:19 +0000 (15:08 -0400)]
Merge pull request #11490 from peterrum/tet_refinement
Enabling global refinement for TET meshes
Martin Kronbichler [Wed, 9 Jun 2021 18:15:54 +0000 (20:15 +0200)]
Merge pull request #12412 from lethe-cfd/particles_ghost_merge
Merge ghost and regular particles in single container
Bruno [Wed, 9 Jun 2021 14:14:39 +0000 (10:14 -0400)]
FIx cell type that is checked
Martin Kronbichler [Wed, 9 Jun 2021 13:21:32 +0000 (15:21 +0200)]
Merge pull request #12417 from gassmoeller/reduce_use_of_particle_class
Do not use Particle class inside ParticleHandler
David Wells [Wed, 9 Jun 2021 13:20:32 +0000 (09:20 -0400)]
Merge pull request #12414 from bangerth/vec-tools-2
Simplify some code for the DG case by referring to the continuous case.
Peter Munch [Sat, 30 Jan 2021 16:47:26 +0000 (17:47 +0100)]
Enabling global refinement for TET meshes
Peter Munch [Wed, 9 Jun 2021 08:20:33 +0000 (10:20 +0200)]
Merge pull request #12401 from kronbichler/mapping_q_cache_vertices
Fix MappingQCache::get_vertices()
Martin Kronbichler [Wed, 9 Jun 2021 05:44:02 +0000 (07:44 +0200)]
Merge pull request #12418 from bangerth/sundials
We no longer support SUNDIALS before version 3.0.
Bruno [Wed, 9 Jun 2021 02:19:59 +0000 (22:19 -0400)]
Fix ghost duplication bug + apply Rene's comments
Wolfgang Bangerth [Tue, 8 Jun 2021 23:29:54 +0000 (17:29 -0600)]
Properly treat the case of piecewise constant elements.
Wolfgang Bangerth [Tue, 8 Jun 2021 17:01:13 +0000 (11:01 -0600)]
Simplify some code for the DG case by referring to the continuous case.
Wolfgang Bangerth [Tue, 8 Jun 2021 23:25:46 +0000 (17:25 -0600)]
We no longer support SUNDIALS before version 3.0.
Bruno Blais [Tue, 8 Jun 2021 21:42:17 +0000 (17:42 -0400)]
Remove last non-necessary note
Bruno Blais [Tue, 8 Jun 2021 17:31:00 +0000 (13:31 -0400)]
Apply Rene comments
Bruno Blais [Tue, 8 Jun 2021 17:05:21 +0000 (13:05 -0400)]
Fix particle duplication + tests
Bruno [Tue, 8 Jun 2021 02:12:28 +0000 (22:12 -0400)]
First WIP version. Issue with exchange ghosts
Martin Kronbichler [Tue, 8 Jun 2021 20:15:04 +0000 (22:15 +0200)]
Merge pull request #12395 from bangerth/vec-tools
Try to see whether we can avoid special-casing for MS VC in one place.
Rene Gassmoeller [Tue, 8 Jun 2021 20:14:53 +0000 (16:14 -0400)]
Do not use Particle class in ParticleHandler
Martin Kronbichler [Tue, 8 Jun 2021 20:14:18 +0000 (22:14 +0200)]
Merge pull request #12402 from drwells/add-initlog-tests
Use initlog in some tests.
Martin Kronbichler [Tue, 8 Jun 2021 20:13:43 +0000 (22:13 +0200)]
Merge pull request #12413 from bangerth/assertion
Add missing assertions.
Peter Munch [Tue, 8 Jun 2021 19:20:49 +0000 (21:20 +0200)]
Merge pull request #12409 from gassmoeller/use_particle_accessor_instead_of_particle
Simplify particle accessor structure
Martin Kronbichler [Tue, 8 Jun 2021 18:28:47 +0000 (20:28 +0200)]
Merge pull request #12410 from jppelteret/fe_interface_values_01
Add FEInterfaceValues::quadrature_point_indices() to support range based loops
Martin Kronbichler [Tue, 8 Jun 2021 17:48:58 +0000 (19:48 +0200)]
Merge pull request #12407 from simonsticko/face_interpolation_1D
Enable get_face_interpolation_matrix() in 1D on FE_Q and FE_Bernstein
Wolfgang Bangerth [Mon, 7 Jun 2021 16:09:33 +0000 (10:09 -0600)]
Try to see whether we can avoid special-casing for MS VC in one place.
This error is currently triggered when running step-21. It is possible that with the move
to get_default_linear_mapping(dof.get_triangulation()) we no longer need this.
Wolfgang Bangerth [Tue, 8 Jun 2021 16:24:20 +0000 (10:24 -0600)]
Add missing assertions.
Jean-Paul Pelteret [Tue, 8 Jun 2021 14:23:55 +0000 (16:23 +0200)]
Add FEInterfaceValues::quadrature_point_indices() to support range based loops
Rene Gassmoeller [Mon, 7 Jun 2021 23:03:53 +0000 (19:03 -0400)]
simplify particle data structure
Simon Sticko [Tue, 8 Jun 2021 11:18:24 +0000 (13:18 +0200)]
Rename test face_interpolation_fe_Bernstein_2_fe_q.cc
Remove the suffix "_2_fe_q" in the filename, since it now tests both
the interpolation FE_Bernstein to Fe_Bernstein and FE_Bernstein to
FE_Q.
Simon Sticko [Tue, 8 Jun 2021 07:42:28 +0000 (09:42 +0200)]
Enable get_face_interpolation_matrix() in 1D on FE_Q and FE_Bernstein
Currently, get_face_interpolation_matrix() on FE_Q and FE_Bernstein
throws an ExcImpossibleInDim(1) exception in 1D. This is strange
because the interpolation matrix should just be a 1-by-1 unit matrix.
Remove the dim > 1 assert in FE_Q_base and FE_Bernstein to fix this
and modify two tests to check that it works.
David Wells [Tue, 8 Jun 2021 11:11:05 +0000 (07:11 -0400)]
Merge pull request #12404 from drwells/gcc11-simplex-p-warnings-2
Fix another GCC11 warning.
David Wells [Tue, 8 Jun 2021 02:37:49 +0000 (22:37 -0400)]
Merge pull request #12406 from marcfehling/pack-unpack
Minor changes to `Utilities::unpack`.
David Wells [Tue, 8 Jun 2021 02:34:30 +0000 (22:34 -0400)]
Merge pull request #12398 from bergbauer/exodusii
Add grid reordering to read_exodusii function
Marc Fehling [Tue, 8 Jun 2021 00:22:32 +0000 (18:22 -0600)]
Merge pull request #12405 from masterleinad/remove_remaining_deprecations_9_2
Remove remaining deprecations in release 9.2
Marc Fehling [Tue, 8 Jun 2021 00:19:49 +0000 (18:19 -0600)]
Merge pull request #12399 from masterleinad/remove_deprecated_feseriers_constructors
Remove deprecated FESeries::Fourier and FESeries::Legendre constructors
Marc Fehling [Tue, 8 Jun 2021 00:18:28 +0000 (18:18 -0600)]
Merge pull request #12394 from bangerth/checks
Simplify the code that leads to an assertion.
Marc Fehling [Tue, 8 Jun 2021 00:17:10 +0000 (18:17 -0600)]
Merge pull request #12400 from drwells/virtual-dtor
Mark a destructor as virtual.
Marc Fehling [Tue, 8 Jun 2021 00:16:05 +0000 (18:16 -0600)]
Merge pull request #12403 from masterleinad/remove_deprecated_compute_vertices_with_ghost_neighbors
Remove deprecated TriangulationBase::compute_vertices_with_ghost_neighbors()
Marc Fehling [Mon, 7 Jun 2021 20:07:12 +0000 (14:07 -0600)]
Add `constexpr` to type check.
David Wells [Mon, 7 Jun 2021 21:15:23 +0000 (17:15 -0400)]
Merge pull request #12397 from bangerth/66
Minor edits to step-66.
David Wells [Mon, 7 Jun 2021 18:12:12 +0000 (14:12 -0400)]
Fix another GCC11 warning.
David Wells [Mon, 7 Jun 2021 18:06:54 +0000 (14:06 -0400)]
Use initlog in some tests.
We forgot to call mpi_initlog() in these tests, which caused the tests to
compare stderr + stdout as output - this is why we had a bunch of problems with
testers collecting additional MPI error output.
Daniel Arndt [Mon, 7 Jun 2021 18:53:35 +0000 (14:53 -0400)]
Remove remaining deprecations in release 9.2
Timo Heister [Mon, 7 Jun 2021 19:01:22 +0000 (15:01 -0400)]
Merge pull request #12396 from bangerth/tut-graph
Reduce the width of the tutorial graph by a little bit.
Wolfgang Bangerth [Mon, 7 Jun 2021 18:44:58 +0000 (12:44 -0600)]
Merge pull request #12391 from marcfehling/hp-fevaluesbase
Make `hp::FEValuesBase` derive from `Subscriptor`.
Daniel Arndt [Mon, 7 Jun 2021 17:03:06 +0000 (13:03 -0400)]
Remove deprecated TriangulationBase::compute_vertices_with_ghost_neighbors()
Martin Kronbichler [Mon, 7 Jun 2021 17:25:41 +0000 (19:25 +0200)]
Fix MappingQCache::get_vertices()
David Wells [Mon, 7 Jun 2021 17:10:50 +0000 (13:10 -0400)]
Merge pull request #12388 from JPmoep/master
Add AssertIndexRange for FEPointEvaluation
Wolfgang Bangerth [Mon, 7 Jun 2021 15:38:28 +0000 (09:38 -0600)]
Simplify the code that leads to an assertion.
We convert integers to doubles so that we can run MPI::MinMaxAvg and then compare
the min against the max. We do this comparison with a tolerance, but that is
unnecessary: If the integer representations are the same, then so are the
floating point representations, bit-by-bit.
David Wells [Mon, 7 Jun 2021 17:00:48 +0000 (13:00 -0400)]
Mark a destructor as virtual.
Daniel Arndt [Mon, 7 Jun 2021 16:09:18 +0000 (12:09 -0400)]
Remove deprecated FESeries::Fourier and FESeries::Legendre constructors
Wolfgang Bangerth [Mon, 7 Jun 2021 16:08:06 +0000 (10:08 -0600)]
Minor edits to step-66.
Wolfgang Bangerth [Mon, 7 Jun 2021 16:07:40 +0000 (10:07 -0600)]
Reduce the width of the tutorial graph by a little bit.
More work is necessary, though.
David Wells [Mon, 7 Jun 2021 15:50:26 +0000 (11:50 -0400)]
Merge pull request #12381 from masterleinad/require_mpi_for_trilinos
Require MPI for Trilinos
Maximilian Bergbauer [Mon, 7 Jun 2021 14:59:12 +0000 (16:59 +0200)]
Add grid reordering to read_exodusii function
Judith Pauen [Fri, 4 Jun 2021 15:03:51 +0000 (17:03 +0200)]
Add AssertIndexRange for FEPointEvaluation
David Wells [Mon, 7 Jun 2021 11:11:26 +0000 (07:11 -0400)]
Merge pull request #12393 from peterrum/simplify_compute_point_to_point_communication_pattern
Simplify compute_point_to_point_communication_pattern() and compute_n_point_to_point_communications()
Peter Munch [Mon, 7 Jun 2021 04:14:42 +0000 (06:14 +0200)]
Merge pull request #11577 from gassmoeller/particle_vector_container
Store particles in vector container
Marc Fehling [Sat, 5 Jun 2021 03:30:45 +0000 (21:30 -0600)]
Make `hp::FEValuesBase` derive from `Subscriptor`.
Rene Gassmoeller [Sun, 6 Jun 2021 21:12:44 +0000 (17:12 -0400)]
Add changelog entry
Martin Kronbichler [Sun, 6 Jun 2021 19:51:39 +0000 (21:51 +0200)]
Merge pull request #12392 from peterrum/cellwise_inserve_mass_factory
Refactor CellwiseInverseMassMatrixImplTransformFromQPoints and use CellwiseInverseMassFactory
Rene Gassmoeller [Sun, 6 Jun 2021 17:39:38 +0000 (13:39 -0400)]
Address comments
Rene Gassmoeller [Wed, 9 Dec 2020 23:59:29 +0000 (18:59 -0500)]
Store particles in a vector
Peter Munch [Sun, 6 Jun 2021 15:11:20 +0000 (17:11 +0200)]
Simplify compute_point_to_point_communication_pattern() and compute_n_point_to_point_communications()
Peter Munch [Sat, 5 Jun 2021 15:07:04 +0000 (17:07 +0200)]
Refactor CellwiseInverseMassMatrixImplTransformFromQPoints and use CellwiseInverseMassFactory
Martin Kronbichler [Sat, 5 Jun 2021 05:59:20 +0000 (07:59 +0200)]
Merge pull request #12377 from peterrum/part_simplify
Simplify workflow of repartitioning
Peter Munch [Tue, 1 Jun 2021 20:34:57 +0000 (22:34 +0200)]
Simplify workflow of repartitioning
Conflicts:
source/grid/tria_description.cc
Peter Munch [Sat, 5 Jun 2021 03:35:33 +0000 (05:35 +0200)]
Merge pull request #12357 from peterrum/create_geometric_coarsening_sequence_new_const
MGTransferGlobalCoarseningTools::create_geometric_coarsening_sequence(): add parameters
Peter Munch [Sat, 5 Jun 2021 03:35:23 +0000 (05:35 +0200)]
Merge pull request #12390 from peterrum/transform_from_q_points_to_basis
CellwiseInverseMassMatrix::transform_from_q_points_to_basis() extension
Peter Munch [Fri, 4 Jun 2021 20:23:15 +0000 (22:23 +0200)]
Merge pull request #12389 from masterleinad/remove_deprecated_vector_tools
Remove deprecated VectorTools functions
Peter Munch [Sun, 30 May 2021 10:58:05 +0000 (12:58 +0200)]
MGTransferGlobalCoarseningTools::create_geometric_coarsening_sequence(): make it optional to coarsen input tria
Peter Munch [Fri, 4 Jun 2021 17:22:48 +0000 (19:22 +0200)]
CellwiseInverseMassMatrix::transform_from_q_points_to_basis: for degree = -1 and degree+1!=q_points_1d
Daniel Arndt [Fri, 4 Jun 2021 14:58:24 +0000 (10:58 -0400)]
Remove deprecated VectorTools
Daniel Arndt [Fri, 4 Jun 2021 13:21:29 +0000 (09:21 -0400)]
Merge pull request #12386 from masterleinad/remove_deprecated_fe_tools_l_to_h_numbering
Remove deprecated FETools::lexicographic/hierarchc_to_hierarchic/lexicographic_numbering
Peter Munch [Fri, 4 Jun 2021 12:28:01 +0000 (14:28 +0200)]
Merge pull request #12387 from peterrum/reduce_fix
Fix ambiguous call in Utilities::MPI::all_reduce
Martin Kronbichler [Fri, 4 Jun 2021 11:27:37 +0000 (13:27 +0200)]
Merge pull request #12379 from simonsticko/fe_q_support_points_dim_1
Add a 0-dimensional face support point on FE_Q<1>.
Martin Kronbichler [Fri, 4 Jun 2021 10:56:22 +0000 (12:56 +0200)]
Merge pull request #12384 from masterleinad/remove_deprecated_cell_accessor_active
Remove deprecated CellAccessor::active()
Martin Kronbichler [Fri, 4 Jun 2021 10:55:47 +0000 (12:55 +0200)]
Merge pull request #12385 from masterleinad/remove_deprecated_vectorized_array_n_array_elements
Remove deprecated VectorizedArray::n_array_elements
Peter Munch [Fri, 4 Jun 2021 10:47:30 +0000 (12:47 +0200)]
Fix ambiguous call in Utilities::MPI::all_reduce
Daniel Arndt [Thu, 3 Jun 2021 19:54:57 +0000 (15:54 -0400)]
Remove deprecated FETools::lexicographic/hierarchc_to_hierarchic/lexicographic_numbering
Timo Heister [Thu, 3 Jun 2021 18:48:55 +0000 (14:48 -0400)]
Merge pull request #12383 from peterrum/DEAL_II_DEPRECATED_EARLY_user
Allow DEAL_II_DEPRECATED_EARLY in user code
Daniel Arndt [Thu, 3 Jun 2021 16:18:18 +0000 (12:18 -0400)]
Remove deprecated VectorizedArray::n_array_elements
Daniel Arndt [Thu, 3 Jun 2021 13:40:25 +0000 (09:40 -0400)]
Remove deprecated CellAccessor::active()
Peter Munch [Thu, 3 Jun 2021 11:19:44 +0000 (13:19 +0200)]
Allow DEAL_II_DEPRECATED_EARLY in user code
Simon Sticko [Wed, 2 Jun 2021 13:24:37 +0000 (15:24 +0200)]
Add a 0-dimensional face support point on FE_Q<1>.
In several places QProjector is used to map the dim-1 dimensional face
support points to dim dimensional points, but this is not possible in
1D because unit_face_support_points currently contains no points for
FE_Q<1>. Add a single 0-dimensional point to unit_face_support_points
to fix this.
David Wells [Thu, 3 Jun 2021 02:40:17 +0000 (22:40 -0400)]
Merge pull request #12382 from masterleinad/remove_deprecated_first_cell
Remove DataOut::first_cell() and DataOut::next_cell()
Daniel Arndt [Wed, 2 Jun 2021 21:44:11 +0000 (17:44 -0400)]
Replace "#if defined(...)" by #ifdef(...)
Daniel Arndt [Wed, 2 Jun 2021 15:56:17 +0000 (11:56 -0400)]
Remove DataOut::first_cell() and DataOut::next_cell()
Daniel Arndt [Wed, 2 Jun 2021 15:52:53 +0000 (11:52 -0400)]
Require MPI for Trilinos
Martin Kronbichler [Wed, 2 Jun 2021 08:01:46 +0000 (10:01 +0200)]
Merge pull request #12376 from masterleinad/remove_deprecated_mg_transfer_build_matrices
Remove deprecated multigrid transfer build_matrices() functions
Martin Kronbichler [Wed, 2 Jun 2021 08:01:08 +0000 (10:01 +0200)]
Merge pull request #12371 from peterrum/pdt_subcomm
TriangulationDescription::Utilities::create_description_from_triangulation(): allow subcommunicator in p::d::T
Peter Munch [Tue, 1 Jun 2021 20:13:32 +0000 (22:13 +0200)]
Merge pull request #12356 from peterrum/create_geometric_coarsening_sequence_new
Add new version of MGTransferGlobalCoarseningTools::create_geometric_coarsening_sequence() that takes partitioner
David Wells [Tue, 1 Jun 2021 20:12:20 +0000 (16:12 -0400)]
Merge pull request #12375 from peterrum/mg_transfer_global_coarsening_mesh_type
Remove MeshType from mg_transfer_global_coarsening.templates.h
Daniel Arndt [Tue, 1 Jun 2021 17:30:53 +0000 (13:30 -0400)]
Remove deprecated multigrid transfer build_matrices() functions
Peter Munch [Tue, 1 Jun 2021 08:27:04 +0000 (10:27 +0200)]
TriangulationDescription::Utilities::create_description_from_triangulation(): allow subcommunicator in pdt
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.