[deal.II] how to use DoFRenumbering::cell_wise(dof_handler)

2024-08-29 Thread ztdep...@gmail.com
I want to change the reordering scheme in step 2 to DoFRenumbering::cell_wise(dof_handler), but it feedback errors. I want to know how to use it correctly. -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/d/forum/dealii?hl

[deal.II] erorr: recompile with -fPIC

2024-08-28 Thread ztdep...@gmail.com
/usr/bin/ld: /home/ztdep/2T/lib/Trilinos-13.4/lib/libnox.a(NOX_Abstract_Vector.C.o): relocation R_X86_64_32S against symbol `_ZTVN7Teuchos11RCPNodeTmplIN3NOX11MultiVectorENS_13DeallocDeleteIS2_' can not be used when making a shared object; recompile with -fPIC -- The deal.II project is l

[deal.II] Does deal.II have a tutorial on the CBS method for fluid flow?"

2024-08-28 Thread ztdep...@gmail.com
Hello everyone, I'm currently exploring the use of the deal.II library for fluid flow simulations. Specifically, I'm interested in implementing the Characteristic-Based Split (CBS) method for solving fluid flow problems. I've gone through some of the deal.II tutorials and documentation, but I

[deal.II] how to treat the intersection point at the first and second kined bcs

2023-11-12 Thread ztdep...@gmail.com
Since the two kinds of bc has one common nodes. I want to know which one is impelented in idealii. -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/d/forum/dealii?hl=en --- You received this message because you are subscr

[deal.II] Does dealii suppport refinement with no haning nodes.

2023-11-05 Thread ztdep...@gmail.com
Does dealii suppport refinement and coarsening with no haning nodes. -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/d/forum/dealii?hl=en --- You received this message because you are subscribed to the Google Groups "de

[deal.II] how to ouput the high order elelment solutions.

2023-11-04 Thread ztdep...@gmail.com
I want to see the position of the nodes in high order elements. Does deallii support this ? -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/d/forum/dealii?hl=en --- You received this message because you are subscribed to

[deal.II] Utilities::MPI::broadcas doesn't work

2023-11-02 Thread ztdep...@gmail.com
I tried to sent a double vector with size of 5 to all other cpus. but it seems no values have been broadcase out. only the root has values in tt vector. all other cpus only have zero values in tt. Could you please help me out. vector tt(5); if(Utilities::MPI::this_mpi_process(mpi_communicator

[deal.II] how to use const std::function< T(const T &, const T &)> & combiner

2023-11-02 Thread ztdep...@gmail.com
I want to use the mpi::all_reduce to add some values from every processes. but i don't know how to set the "const std::function< T(const T &, const T &)> & combiner". Could you please give me some help about it? Utilities::MPI::all_reduce ( const T & local_value, const MPI_Comm & comm, c

[deal.II] Does deal.ll support import grid from openfoam solver

2023-07-15 Thread ztdep...@gmail.com
I want to couple the mesh adaptivity off deal.ll with openfoam solver. Could you please give me some suggestions. -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/d/forum/dealii?hl=en --- You received this message because

[deal.II] how to define periodic bc in delal.II

2023-07-11 Thread ztdep...@gmail.com
I waant to know how to define periodic bc in delal.II. -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/d/forum/dealii?hl=en --- You received this message because you are subscribed to the Google Groups "deal.II User Gro

[deal.II] does deal.ll support order 8 elements?

2023-07-04 Thread ztdep...@gmail.com
does deal.ll support order 8 elements? what is the highest order element deal.ll support. -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/d/forum/dealii?hl=en --- You received this message because you are subscribed to t

[deal.II] the ordering of the vertex is changed after read in mesh

2023-07-04 Thread ztdep...@gmail.com
I read in the mesh from "unv" file. but i found that the vertex ordering is changed. in the origin unv file : the vertex of a cell is 9 6 3 7. but in deall.ll it gives: 63 9 7 I don't understand why this had happened. -- The deal.II project is loc

[deal.II] How to get the vertex index on all the boundaries.

2023-07-02 Thread ztdep...@gmail.com
I read in 2d mesh from "unv" file and i want to get all the vertex index on all the boundaries and also output the name of the each boundaries. Could you please give me some suggestions. -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://g

[deal.II] Tutorial 40 , error: use of deleted function

2022-11-07 Thread ztdep...@gmail.com
when i compile the tutorial 40, i met the following error. It semms that the function has been deleted. error: use of deleted function ‘dealii::parallel::distributed::Triangulation::Triangulation(const MPI_Comm&, typename dealii::Triangulation::MeshSmoothing, dealii::parallel::distributed::T

[deal.II] How to extract the the matrix A in crs format

2022-10-31 Thread ztdep...@gmail.com
I want to extract the matrix A and rhs in crs format , and pass them to my own solver. Could you pleae give me some advices. -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/d/forum/dealii?hl=en --- You received this mes

[deal.II] how to set the boundary name day and output to the file.

2022-10-28 Thread ztdep...@gmail.com
I am running the first example "first_grid". I want to know does deal.ii support the defination of the boundary name and output it to a readable file. I have output the grid to ucd file , but no boundary infors are stored in the ucd file. Could you please give me some advices. -- The deal

[deal.II] Does deal.II support readin a matirx market file and plot it sturcture out.

2022-09-03 Thread ztdep...@gmail.com
Does deal.II support readin a matirx market file and plot it sturcture out. -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/d/forum/dealii?hl=en --- You received this message because you are subscribed to the Google Group

[deal.II] Reference on "Solving a Laplace problem Using mean value constraints"

2022-08-26 Thread ztdep...@gmail.com
In step 11, Solving a Laplace problem with higher order mappings. Using mean value constraints. Could you please provide some references about the implementation process. -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/

Re: [deal.II] How to implemente the Neumann bc for laplacian

2022-08-26 Thread ztdep...@gmail.com
the data (rhs, Neumann condition,...) of your problem ? > What is the value of the residual ? > > Best, > Marco > > On 26 Aug 2022, at 13:48, ztdep...@gmail.com wrote: > > it seems I cann't get a converged solution . which Solver should i > use to treat t

[deal.II] Re: How to implemente the Neumann bc for laplacian

2022-08-26 Thread ztdep...@gmail.com
the neumann data. >> >> Best, >> Marco >> Il giorno martedì 23 agosto 2022 alle 15:54:19 UTC+2 ztdep...@gmail.com >> ha scritto: >> >>> In step 3 , I want to implemente the Neumann bc for all the boundary >>> condition. which tutorial show this

[deal.II] How to implemente the Neumann bc for laplacian

2022-08-23 Thread ztdep...@gmail.com
In step 3 , I want to implemente the Neumann bc for all the boundary condition. which tutorial show this procedure. -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/d/forum/dealii?hl=en --- You received this message becau