[deal.II] Re: shape_value, shape_grad in arbitrary points within quad that are not quadrature points

2018-08-17 Thread Daniel Arndt
Juan, I would like to ask what would be the best/fastest way to evaluate *fe_v.shape_value > (i,x), **fe_v.shape_grad* *(i,x)*, in points that are not quadrature > points but that are guaranteed to lie within the curved cell/quad. > If I understand the situation correctly, you have a FEValues o

[deal.II] Re: implemention of periodic boundary condition

2018-08-10 Thread Daniel Arndt
Chucui, But if "periodic boundary condition" means that all information of solution > on periodic faces pair are equal, not only the value of solution (like > Dirichlet boundary condition above), but also gradient value of solution > (like Neuman boundary condition, as normal vector is opposite

[deal.II] Re: implemention of periodic boundary condition

2018-08-09 Thread Daniel Arndt
Chucui, Maybe a question more : how to make sure your period boundary coditions are > added truly? > How would you do it for Dirichlet boundary conditions? There are mutiple possibilities. - You can just print the constraints (ConstraintMatrx.print(std::cout)), print the locations of degrees of

[deal.II] Re: Normal flux as essential boundary condition

2018-08-08 Thread Daniel Arndt
Konrad, VectorTools::project_boundary_ > values_div_conforming > > > is > > then a

Re: [deal.II] implemention of periodic boundary condition

2018-08-08 Thread Daniel Arndt
Chucui, it is clearly suspicious that you don't use any of your ConstraintMatrix objects in the assembly loops. Instead of calling system_matrix.add(local_dof_indices[i], local_dof_indices[j], local_matrix(i, j)); you should use const

[deal.II] Re: implemention of periodic boundary condition

2018-08-08 Thread Daniel Arndt
Chucui, In first sight this looks reasonable. In particular, it is important to consider the constraints when building the sparsity pattern. Can you build a minimal working example that shows the problem? Best, Daniel -- The deal.II project is located at http://www.dealii.org/ For mailing list

[deal.II] Re: implemention of periodic boundary condition

2018-08-08 Thread Daniel Arndt
Chucui, 1. How to use function "DoFTools::make_periodicity_constraints() " only? > if my code need not to compute parallel case. If I choose [...] how to > choose face1 and face2 we need there correctly? If I use [...] maybe I > still need to use "GridTools::collect_periodic_faces" to input i

Re: [deal.II] Writing the heat equation in cylindrical coordinates

2018-05-23 Thread Daniel Arndt
> > > > I tried to implement the static heat equation in cylindrical coordinates > on a > > 2d-plane, while being radially symmetric at x = 0. That leads me to the > > following weak formulation of the problem (while neglecting the factor > 2\pi): > > > > \int\limits_0^R \nabla U\nabla\phi r

[deal.II] Re: Constrain specific dofs to given value

2018-05-17 Thread Daniel Arndt
Pai, I found that I forget to add other boundary conditions, and in this case > the stiffness matrix is in fact singular. > From my understanding, if I want to constrain a dof "i" to zero, instead > of adding a constraint of dofs "i, j, k, ...", I may only need the add_line > function. > For my

[deal.II] Re: Problem about modifying CMakeList.txt to add library

2018-05-16 Thread Daniel Arndt
Pal, We also just updated the CMakeLists.txt file for an example in our code-gallery that uses armadillo. You might want to look at https://github.com/dealii/code-gallery/blob/master/CeresFE/CMakeLists.txt. Best, Daniel -- The deal.II project is located at http://www.dealii.org/ For mailing l

[deal.II] Re: Where to get Adol-C?

2018-05-14 Thread Daniel Arndt
Maxi, I would like to include Adol-C in my deal.II-library. Now deal.II needs at > least the version 2.6.4 from adol-c, but on the current web page to this > project (https://projects.coin-or.org/ADOL-C) the newest version is > 2.6.3. Thus I was wondering how I could obtain a newer version to u

Re: [deal.II] Re: Epetra_FEVector not being created as a LinearMap

2018-05-12 Thread Daniel Arndt
Josh, The key issue for my application is whether the make_trilinos_map method of > the IndexSet class is called with overlapping equal to true or false. At > the moment, when make_trilinos_map is called from the reinit method for > Vector in the TrilinosWrappers∷MPI namespace, overlapping is a

[deal.II] Re: Initialising vector solution for mixed formulation problem

2018-05-10 Thread Daniel Arndt
Jane, > the error i was getting was: > > void dealii::VectorTools::interpolate(const Mapping &, > const DoFHandlerType &, const Function VectorType::value_type> &, VectorType &, const dealii::ComponentMask &) > [dim = 2, spacedim = 2, VectorType = dealii::BlockVector, > DoFHandlerType = Do

[deal.II] Re: Initialising vector solution for mixed formulation problem

2018-05-07 Thread Daniel Arndt
Jane, [...] > > Now, > VectorTools::interpolate(dof_handler, exact_solution, solution); > > gives me a dimension mismatch error - I'm assuming that this is due to the > fact that RT elements can't distinguish between the x and y components. > I would expect that RT elements are not interpolator

Re: [deal.II] Re: Rescale dimensions of system before output

2018-05-07 Thread Daniel Arndt
Maxi Furthermore I tested the transform-function, and got the following error: > ~/heat_equation_with_pulse_propagation/heat_equation/source/main.cpp:1648: > 26: error: no matching function for call to ‘transform(std::_Bind_helper< > false, dealii::Point<2, double> (Step15::MinimalSurfaceProblem<

[deal.II] Re: C1 elements for 4th order derivatives

2018-05-07 Thread Daniel Arndt
Yaakov, Mixed formulation seems not so fast, can we have other choices in Dealii to > solve C1 Problems? e.g. Meshfree? > What exactly do you mean by the "Mixed formulation seems not so fast"? Do you have an implementation using a mixed formulation that appears to be too slow? If so, it would b

[deal.II] Re: Rescale dimensions of system before output

2018-05-01 Thread Daniel Arndt
Maxi, Am Dienstag, 1. Mai 2018 13:39:58 UTC+2 schrieb Maxi Miller: > > I tried to make my equation unitless, in order to make calculations > easier. For that I also had to rescale the boundaries, defined by p1 = > Point(x0, y0) and p2 = Point(x1, y1) to p1_u = Point(0, 0) > and p2_u = Point(1,

[deal.II] Re: deal.II Compact Course - 09--13 April 2018, Heidelberg, Germany

2018-04-27 Thread Daniel Arndt
Yaakov, does such a course start in every semester (SS/WS)? > No, it takes place annually. Best, Daniel -- 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

[deal.II] Re: error running after update

2018-04-24 Thread Daniel Arndt
Jane, this looks like you are using a compiler (clang on macOS?) that doesn't define std::auto_ptr anymore and the used boost library doesn't detect this. A recent developer version (there will soon be a release) should circumvent the problem. How did you install deal.II? Are you using spack dir

[deal.II] Re: Constraints on support points on Q2 elements and output

2018-04-11 Thread Daniel Arndt
Jie, > I need to constrain all the support points on a Q2 element instead of only vertices. The constrained values (inhomogeneity) are obtained from (conceptually) a function, say f(\bold{x}). The code below suggests that you want to constraint all degrees of freedom. Is this really what you i

[deal.II] Re: Unable to find function definition of GridTools::exchange_cell_data_to_ghosts

2018-04-08 Thread Daniel Arndt
Pratik, I dont know how feasible it would be, but maybe you could move it to > grid_tools.cc . It seems that even doxygen > > does not pick up the source code as it does for all the other functions. > The reason why this

[deal.II] Re: Unable to find function definition of GridTools::exchange_cell_data_to_ghosts

2018-04-08 Thread Daniel Arndt
Pratik, I was looking for how the function GridTools::exchange_cell_data_to_ghosts > works. I can find the function declaration here > > > (line 2392). But I cannot seem to find

[deal.II] Re: deal.II cannot found HDF5

2018-04-07 Thread Daniel Arndt
Peng, it is hard to tell what is going wrong with just that little information. What did you actually try to enable HDF5 in deal.II? Did you configure deal.II via $ cmake -DDEAL_II_WITH_HDF5=ON -DHDF5_DIR=/path/to/hdf5_dir deal_II_source_dir ? If so, what is the output you get? Can you show us y

[deal.II] Re: Difference between dim and spacedim

2018-04-05 Thread Daniel Arndt
Weixiong, Have a look at step-38 (https://www.dealii.org/8.5.0/doxygen/deal.II/step_38.html) for an example. We oftn assume that the domain we want solve on has (locally) the same dimension (dim) as the space it is embedded in (spacedim). However, this must not be true and we can solve PDEs also

[deal.II] Re: manifold for multiple circles on 2D plane

2018-04-03 Thread Daniel Arndt
Weixiong, The initial description might be misleading. What I tried to do is > repeatedly set manifolds for circles on X-Y plane. Now I use STL container > to contain different pointers of SphericalManifold instance and > correspondingly assign distinct manifold ids, it worked out. But it migh

[deal.II] Re: manifold for multiple circles on 2D plane

2018-04-03 Thread Daniel Arndt
Weixiong, [...] > In 3D, I use CylindricalManifold<3> with axis=2 for the fold type. Yet, I > just realize being stuck in 2D that axis=2 is not available for > CylindricalManifold<2> ( 0 or 1 cannot give me the z-oriented cylinder ). > What is it you are trying to achieve? We identify the first

[deal.II] Re: use of "meshworker" for FESystem

2018-03-25 Thread Daniel Arndt
Jaekwang, do you have a minimal compilign example that shows the problem? Did you call dof_handler.distribute_dofs(fe)? Best, Daniel -- 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

Re: [deal.II] p4est critical number of elements in each Proc

2018-03-25 Thread Daniel Arndt
Qing, MeshSmoothingyou are using Triangulation::MeshSmoothing(Triangulation::smoothing_on_refinement) which might result in no cells being refined at all. This is why you get an inifinite loop. Removing the mesh smoothing should avoid this issue. Another problem might be that GridTools::minima

[deal.II] Re: undefined reference link error of refinement under parallel framework

2018-03-17 Thread Daniel Arndt
Qing, parallel::diistributed::Triangulation doesn't support dim==1. Therefore, parallel::distributed::GridRefinement::refine_and_coarsen_fixed_number is not instantiated for this case indeed. If you want to do computations in 1d, you have to use the regular (serial) Triangulation class or the p

[deal.II] Re: GridTools::collect_periodic_faces has problem with meshes generated by Gmsh or Abaqus when running in parallel.

2018-02-17 Thread Daniel Arndt
Hamed, for collecting the periodic boundary pairs only the coarsest level is important. In particular, you have to make sure that you set the boundary indicators correctly for all cells on this level. For the coarsest level every MPI process knows about all the cells since the mesh is the same

[deal.II] deal.II Compact Course - 09--13 April 2018, Heidelberg, Germany

2018-02-11 Thread Daniel Arndt
information see the corresponding homepage <http://www.mathsim.eu/~darndt/index.php?section=index&subsection=compact-course-dealii> . <http://indico.sissa.it/e/sixth-dealii-workshop> Best regards, Daniel Arndt -- Daniel Arndt Interdisciplinary Center for Scientific Computing (IWR

[deal.II] Re: assertion failed: be_value_from_constant: unknown constant kind (shared/cfe/edgglue/edg_decl.c, line 1374)

2018-01-31 Thread Daniel Arndt
Lev, https://github.com/dealii/dealii/pull/5833 provides a workaround for this issue. Best regards, Daniel Am Dienstag, 19. Dezember 2017 22:23:22 UTC+1 schrieb Lev Karatun: > > Hi everyone, > > I was trying to update dealII to the latest version, but I'm getting an > error: > >> [ 47%] Buildi

[deal.II] Re: Hanging node constraints and periodic constraints together causing an issue

2018-01-23 Thread Daniel Arndt
Sambit, Please try if https://github.com/dealii/dealii/pull/5779 fixes the issue for you. Best, Daniel Am Dienstag, 16. Januar 2018 22:06:55 UTC+1 schrieb Sambit Das: > > Thank you, Dr. Arndt. > > Best, > Sambit > > On Tuesday, January 16, 2018 at 11:16:08 AM UTC-

[deal.II] Re: the viscous term in SUPG stabilization terms

2018-01-17 Thread Daniel Arndt
Feimi, u^h \cdot grad{w^h} \cdot laplacian{u^h} for SUPG and > grad{q^h} \cdot laplacian{u^h} for PSPG. > > Where u^h is the trial function and w^h, q^h refer to the velocity and > pressure test function, respectively. > It seems impossible to calculate these terms with linear elements (because

[deal.II] Re: Hanging node constraints and periodic constraints together causing an issue

2018-01-16 Thread Daniel Arndt
Sambit, I created an issue at https://github.com/dealii/dealii/issues/5741 with a modified version of your example. Best, Daniel -- 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 thi

Re: [deal.II] Looking for more info on FE_RaviartThomas

2017-12-14 Thread Daniel Arndt
Praveen, > Also, is it possible to get this notes that Guido has posted > > http://www.mathsim.eu/~gkanscha/notes/mixed.pdf > > > which seems to be inac

[deal.II] Re: candi deal.ii

2017-12-12 Thread Daniel Arndt
Peimeng, adding to what Uwe said, you don't need to a fortran compiler to build PETSc. In particular, you can try to also set `--with-fc=0` in deal.II-toolchain/packages/petsc.package CONFOPTS. Best, Daniel -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum opt

Re: [deal.II] Re: DoFTools::make_hanging_node_constraints affecting DoFTools::make_periodicity_constraints for a single element triangulation with no hanging nodes

2017-12-11 Thread Daniel Arndt
Sambit, just for confirmation: the first problem with your test is that calling the constructor FE_Q with a (one-dimensional) Quadrature formula requires the first point to be 0 and the last one 1 as described in the documentation.

[deal.II] Re: Moving vertices of parallel triangulation breaks periodic face pair match

2017-12-11 Thread Daniel Arndt
Sambit, It turned out that there was indeed a bug in `parallel::distributed::Triangulation::communicate_locally_moved_vertices` in that we didn't update vertices across periodic faces correctly. PR #5612 Since you provided the major part of the added

[deal.II] Re: Handling Dirichlet Boundary conditions with Hanging Nodes

2017-12-09 Thread Daniel Arndt
Phani, > I have a general query. Is there anything I should be particularly careful > when I have to handle non-homogenous dirichlet boundary on a mesh with > hanging nodes on the boundary? I am working in the matrix-free data > structure format. I am trying to impose non-homogenous boundary c

Re: [deal.II] Re: mapping_collection and step-27

2017-12-09 Thread Daniel Arndt
Juan, take a look at the documentation of that function. It tells you that the last parameter needs to be "false", i.e. this function is only implemented for the case in which you don

[deal.II] Re: value_list function to compute_nonzero_normal_flux_constraints

2017-12-09 Thread Daniel Arndt
Giovanna, I have tried defining a more general function as a list of points and > values associated with those points (using vector_value_list). This > definition is based on the output of another simulation (with > post-processing of the solution gradient at the boundary). I used the > verti

[deal.II] Re: Seg fault using Extracting hanging node dofs in MPI

2017-12-09 Thread Daniel Arndt
Phani, apparently no one used this function for a parallel::distributed::Triangulation before. The problem is that we don't know about DoFs on artficial cells. The pull request https://github.com/dealii/dealii/pull/5604 fixes this issue by extracting DoFs belonging to locally owned cells. Essen

[deal.II] Re: Moving vertices of parallel triangulation breaks periodic face pair match

2017-12-06 Thread Daniel Arndt
Sambit, I am using the GridTools::collect_periodic_faces(..) as a sanity check > after moving the triangulation. I donot again set periodicity constraints. > The documentation also mentions "it is possible to call this function > several times with different boundary ids to generate a vector wi

[deal.II] Re: Moving vertices of parallel triangulation breaks periodic face pair match

2017-12-05 Thread Daniel Arndt
Sambit, your minimal example fails, because you are calling GridTools::collect_periodic_faces(triangulation, /*b_id1*/ 2*i+1, /*b_id2*/ 2*i+2,/*direction*/ i, periodicity_vector); after triangulation.refine_global(2); again. As explained in the documentation

[deal.II] Re: Using FunctionMap for nonzero normal flux (eg in step-22)

2017-12-04 Thread Daniel Arndt
Jane, I'm wondering whether I've misunderstood how to use the FunctionMap > declaration. I'm needing it to use for > VectorTools::compute_nonzero_normal_flux_constraints > > At the moment I am trying to apply nonzero normal component of the normal > stress in step-22 on a boundary id that is 2

[deal.II] Re: Moving vertices of parallel triangulation breaks periodic face pair match

2017-12-04 Thread Daniel Arndt
Sambit, I am trying to move all parallel triangulation nodes by a constant > displacement, but that breaks the periodic face pairs match when I > call GridTools::collect_periodic_faces(...). I use the following code for > the mesh movement. The dftPtr->triangulation has periodicity constraints

[deal.II] Re: how to refine only the outer cells of a mesh?

2017-12-04 Thread Daniel Arndt
Alex, have a look at step-1 . The relevant piece of code there looks like Triangulation<2>::active_cell_iterator cell = triangulation.begin_active

[deal.II] Re: time dependent problem with time dependent dirichlet boundary conditions

2017-12-04 Thread Daniel Arndt
Bhanu, [...] > VectorTools::interpolate_boundary_values(move_dof_handler, 106, > move_boundary_values_function, move_boundary_values); > MatrixTools::apply_boundary_values(move_boundary_values, > move_system_matrix, move_solution, move_system_rhs); > > instead of 'constraints'. > No

Re: [deal.II] Re: Error during p4est installation

2017-12-01 Thread Daniel Arndt
Yaakov, looking at p4est-install.sh, the error tells you that "SRCDIR/src/p4est.h" can't be found. This might mean that your p4est-1.1.tar.gz is broken or incomplete. Can you make sure that "src/p4est.sh" indeed exists after unpacking the archive? If not, try to download p4est-1.1.tar.gz again.

[deal.II] Re: Boost errors

2017-11-14 Thread Daniel Arndt
Praveen, can you provide us with a minimal example showing the problem? Since this problem doesn't appear when compiling the library, it is difficult to guess the cause. Best, Daniel > -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://gro

Re: [deal.II] Test 4 failed, maybe different installation of MPI? then how to solve this?

2017-10-28 Thread Daniel Arndt
Michael, are actually compiling with a MPI compiler? Does replacing NULL by nullptr help? Best, Daniel Am Samstag, 28. Oktober 2017 01:52:24 UTC+2 schrieb Michael: > > Thanks for your reply. I did install mpich_3.2-7_amd64.deb before. When I > tried your simple mpi example, I can not even compi

[deal.II] Re: Installation error, please help, thx!

2017-10-25 Thread Daniel Arndt
Michael, can you just provide us with the full make output when starting from a clean build directory? Best, Daniel -- 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 bec

[deal.II] Re: mapping_collection and step-27

2017-10-23 Thread Daniel Arndt
Juan [...] > >static std::map bval; > VectorTools::interpolate_boundary_values (mapping_collection, > dof_handler, ZeroFunction(), bval); > > and I get the following error: > > [100%] Building CXX object CMakeFiles/pFEM.dir/pFEM.cc.o > /home/ju4nk4/jc/codes/adaptivity/disk_pFEM/pFEM.cc:

[deal.II] Re: Signal: Segmentation fault in parallel::distributed::Triangulation

2017-10-20 Thread Daniel Arndt
Yiayng, Am Freitag, 20. Oktober 2017 01:42:09 UTC+2 schrieb Yiyang Zhang: > > Hello Daniel, > > I am using the following code on my macbook. > > mpirun -n 1 xterm -e lldb ./test : -n 1 ./test > So you are running into the error with only one MPI process as well? Then, you should be able to omit t

[deal.II] Re: Signal: Segmentation fault in parallel::distributed::Triangulation

2017-10-19 Thread Daniel Arndt
Yiyang, what do you see if you run this in a debugger on a interactive node, i.e. something like mpiexec -np 2 xterm -e gdb ./your_program ? Since this is a segmentation fault I would expect that you should be able to find the exact failing statement this way without too much problems. I have

[deal.II] Re: Block problem +MatrixFree

2017-10-01 Thread Daniel Arndt
Michael, I implemented something similar to what you proposed. You might want to have a look at https://github.com/dealii/dealii/pull/5175 Best, Daniel Am Mittwoch, 27. September 2017 17:41:08 UTC+2 schrieb Michał Wichrowski: > > >> I've started working on new version MGTransferBlockMatrixFree

[deal.II] Re: Block problem +MatrixFree

2017-09-26 Thread Daniel Arndt
Michael, Adding to Wolfgang's response: Am Dienstag, 26. September 2017 17:42:41 UTC+2 schrieb Michał Wichrowski: > > Dear all, > I'm dealing with Stokes problem that I want to solve using matrix-free > methods. In tests I've alredy found implementation of Stokes operator that > uses block vec

Re: [deal.II] Re: about deal.II with CUDA C programming acceleration

2017-08-23 Thread Daniel Arndt
Chih-Che, [...] > Build FAST version in /work2/chueh/deal.II_project/p4est/p4est-build/FAST > configure: WARNING: Static source code checker splint not found > configure: WARNING: Static source code checker splint not found > FAST version installed in /work2/chueh/deal.II_project/p4est/FAST > > Bu

Re: [deal.II] Re: Solving space-dependent equations using dealII?

2017-08-22 Thread Daniel Arndt
Maxi, adding to Wolfgang's answer: if you only want to visualize all time steps (or the z-dependency) at once, you can use DataOutStack[1] for this. Best, Daniel [1] https://www.dealii.org/8.5.0/doxygen/deal.II/classDataOutStack.html Am Dienstag, 22. August 2017 18:01:38 UTC+2 schrieb Wolfgan

[deal.II] Re: Solving space-dependent equations using dealII?

2017-08-22 Thread Daniel Arndt
Maxi, Is it possible to solve not only time-, but also space-dependent equations > in dealII? As example the nonlinear schrödinger equation: > \partial_z U = i(\partial_x^2+\partial_y^2) U > with U=U(x, y, z) and U_0=U(x, y, 0)? As far as I know until now, all the > equations are based on time,

[deal.II] Re: Usage of the laplace-matrix in example 23

2017-08-22 Thread Daniel Arndt
Maxi, citing from the documentation of step-23[1]: "In a very similar vein, we are also too lazy to write the code to assemble mass and Laplace matrices, although it would have only taken copying the relevant code from any number of previous tutorial programs. Rather, we want to focus on the th

Re: [deal.II] Can someone send me an offline documentation of dealii?

2017-08-18 Thread Daniel Arndt
Alternatively, you can also build the documentation yourself using the instructions at https://www.dealii.org/developer/readme.html#documentation Best, Daniel -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/d/forum/deali

[deal.II] Re: Datapostprocessor first derivative based on what?

2017-07-27 Thread Daniel Arndt
Jaekwang, DataOut creates data at each corner of each cell. However, DataOutFilter[1] allows to reduce the number of data to just one value for each vertex. Answering your question: DataPostprocessor doesn't choose a value but the output includes all of them. Best, Daniel [1] https://www.deal

[deal.II] Re: The violated condition was: (dst_local_size) == (static_cast(matrix->RangeMap().NumMyPoints()))

2017-07-15 Thread Daniel Arndt
franck75, Some hints for debugging this: Do you observe this error only if you run in parallel or also with only one MPI process? Use gdb to find the last line in your program that triggers the Assert. Which line is it? Try to find out where the numbers 81 and 45 come from. The best candidates

Re: [deal.II] Best approach for multi-variable system with multiple grids

2017-07-15 Thread Daniel Arndt
Maxi, I know that both components will behave quite differently, thus I assumed > that I have to use two grids. > Having to deal with two grids always creates a lot of overhead for the coupling terms. So you normally want to avoid this if you can. > In addition I was interested in how both p

[deal.II] Re: Modification of example 33 correct, or not?

2017-07-15 Thread Daniel Arndt
Maxi, can you clarify which of the variables and coefficients are vector-valued and which a scalar-valued? Do all your \cdot relate to scalar products? Can you write down \nabla \cdot (k_N\cdot N) in components? Assuming that N, T_E and T_L are scalar, (k_N\cdot N) should be vector-valued for t

[deal.II] Re: define 2D/3D Point

2017-07-07 Thread Daniel Arndt
Lisa, you can write something like Point p; switch(dim) { case 1: p = Point (1); break; case 2: p = Point (1, 2); break; case 3: p = Point (1, 2, 3); break; default: Assert(false, ExcNotImplemented()); } const Point test_point = p; Best, Daniel -- The dea

[deal.II] Re: About applying periodic boundary condition on the same mesh by different methods

2017-07-05 Thread Daniel Arndt
Chuyi, i finished it. But i think in the second step > ConstraintMatrix::get_constraint_lines() should be > (*constraint_entries)[0].first by calling constraint_entries = > ConstraintMatrix::get_constraint_entries(* IndexSet::ElementIterator), > right? > Yes, you're right ConstraintMatrix::ge

[deal.II] Re: point load

2017-07-03 Thread Daniel Arndt
Mahsa, > I am learning how to use Deal.II recently. I want to apply point load at > the point of (+1,+1) in step 8 with neuman boundary condition but I have > problem in applying point load. Would you please help me? how can I apply a > point load with magnitude of 10 in that point? > You prob

[deal.II] Re: hp HDG in deal.II

2017-06-26 Thread Daniel Arndt
Samuel, Thanks for your answer, your approach actually worked quite well. > Thanks! > (How would I go about submitting a patch? I have absolutely no experience > with these things) > Have a look the FAQ [1]. If you have problems doing this, we happily help. > Now I have another question. I

[deal.II] Re: About applying periodic boundary condition on the same mesh by different methods

2017-06-26 Thread Daniel Arndt
Chuyi, I still have a question about how to apply periodic boundary conditons: Is > there any possibility now to apply PBC with a value 1.0 in x_component and > y_component while -1.0 in z_component? I've read an older version of > step-45 before (like 8.3.0), which showed we could change that

[deal.II] Re: project or interpolate initial condition on PetscWrappers::MPI::Vector

2017-06-22 Thread Daniel Arndt
Marek, > InitialValuePhase ()solution_phase_n > > solution_phase_n.reinit (locally_owned_dofs_phase, > locally_relevant_dofs_phase, > MPI_COMM_WORLD); > > TrilinosWrappers::Vector vec_old_solution (dof_handler_phase.n_dofs > ()); > > VectorTools::interp

[deal.II] Re: Any easy how-to: petsc and solver preconditioner selection from input?

2017-06-13 Thread Daniel Arndt
Weixiong, Am Samstag, 10. Juni 2017 12:54:50 UTC+2 schrieb Weixiong Zheng: > > Hi all, > > I am developing something based on petsc solvers and preconditioners. We > actually expect to invoke user-requested solvers and preconditioners from > the input file. > > I saw selector classes for deal.II

[deal.II] Re: get_function_value error with hp class

2017-06-13 Thread Daniel Arndt
Weixiong, [...] > Then I got confused: > 1. I used hp class a year ago or so, fv.get_function_values works > directly. Now I have to use the above change. Did I do something wrong? > 2. Then why fv.shape_value still works as it did? Isn't fv still a > FESystem object? > How did you initialize h

Re: [deal.II] compress error for vector of PETScWrappers::MPI::SparseMatrix

2017-06-07 Thread Daniel Arndt
Weixiong, [...] > SparsityTools::distribute_sparsity_pattern (dsp, > > dof_handler.n_locally_owned_dofs_per_processor (), > mpi_communicator, >locally_owned_dofs); > This looks a bit suspicious. Normal

[deal.II] Re: About applying periodic boundary condition on the same mesh by different methods

2017-06-01 Thread Daniel Arndt
Chuyi, > i was trying to use Dealii to solve a 3-dimensional elastic-plastic > question on a cubic by applying periodic boundary condition like in step-45 > (v. 8.5.0). > std::vector:: > cell_iterator> > periodicity_vector; > GridTools::collect_periodic_faces(dof_handler, 1, 2, 2, periodicity_

Re: [deal.II] Re: Step 13 & 14 -- Different BCs on different boundary indicators

2017-05-17 Thread Daniel Arndt
Dear Elena, I want to do something like below code, but I don't know how to write it > correctly: > > template > void > Solver::*assemble_linear_system *(LinearSystem &linear_system) > { > > VectorTools::interpolate_boundary_values (dof_handler, >

[deal.II] Re: Adding periodicity to a thin sample with one element in thickness direction

2017-05-16 Thread Daniel Arndt
Dear Hamed, However, I think it is not the producing of the final refined mesh that > hangs the code but the add_periodicity when repetition parameter is > relatively large(100 for instance). Since, it has been mentioned in the > documentation that refinement of the course mesh should be applie

[deal.II] Re: Step-42

2017-05-15 Thread Daniel Arndt
Benhour, `make run` gives me: Scanning dependencies of target step-42 [ 33%] Building CXX object CMakeFiles/step-42.dir/step-42.cc.o [ 66%] Linking CXX executable step-42 [ 66%] Built target step-42 Scanning dependencies of target run [100%] Run step-42 with Debug configuration *** Call this prog

[deal.II] Re: Getting error during cmake configuration step and later during make run

2017-05-15 Thread Daniel Arndt
Vikram, > I am new to dealii. I installed deal.II 8.5.0 using the dmg package from > dealii website on mac OS Sierra. When I tried to configure I got this error: > > CMake Error at > /Applications/deal.II-8.5-brew.app/Contents/Resources/brew/Cellar/cmake/3.7.2/share/cmake/Modules/CMakeTestCXXCom

[deal.II] Re: Step-42

2017-05-15 Thread Daniel Arndt
Ben, I tried with version 8.4.1 and also the new version, 8.5, however it does > not run at all. The errors that I got are given as below: > make[3]: *** [CMakeFiles/run] Error 1 > make[2]: *** [CMakeFiles/run.dir/all] Error 2 > make[1]: *** [CMakeFiles/run.dir/rule] Error 2 > make: *** [run] Err

[deal.II] Re: Adding periodicity to a thin sample with one element in thickness direction

2017-05-14 Thread Daniel Arndt
Hamed, > To the best of my knowledge, GridGenerator::subdivided_hyper_rectangle >> generates a coarsest level mesh (i.e. all cells have level = 0) with the >> given discretisation in each coordinate direction. >> > > It seems that GridGenerator::subdivided_hyper_rectangle needs repetition >

[deal.II] Re: Step-42

2017-05-14 Thread Daniel Arndt
Ben, I really appreciate it if you let me know how I can run step 42 because > whenever I ran it, I got two error without any information about that. This > is exactly the same with "goal oriented mesh adaptivity in elastoplasticity > proiblems" example which is written by Shahram. Looking forw

[deal.II] Re: Crack propagation

2017-05-14 Thread Daniel Arndt
Jack, have a look at https://github.com/tjhei/cracks Best, Daniel Am Freitag, 12. Mai 2017 07:57:06 UTC+2 schrieb Jack: > > Hi S. A. Mohseni, > > I'm also interested on the cracking mechanics, where is such an example > for crack propagation ? > > Thanks ! > > 在 2017年3月30日星期四 UTC+8下午9:13:16,Se

Re: [deal.II] AssertDimension (partition_blocks[partition], task_info.n_blocks) when calling MatrixFree::reinit() for finest level in GMG

2017-05-14 Thread Daniel Arndt
Denis, this is solved by https://github.com/dealii/dealii/pull/4376, isn't it? -- 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 G

[deal.II] Re: method/function from Triangulation class that returns a vertex

2017-05-11 Thread Daniel Arndt
Bhanu, Am Donnerstag, 11. Mai 2017 12:08:52 UTC+2 schrieb Bhanu Teja: > > Dear dealii developers/users > > is there a method/function from Triangulation class that returns the > vertex given its global_index? > There is "Triangulation::get_vertices"[1] which returns a std::vector to all vertice

[deal.II] Re: Compilation fail with dealii 8.5.0 from Docker

2017-05-11 Thread Daniel Arndt
Ashkan, I tried to compile my application with the new dealii 8.5.0 but it fails. > > In my program I user distributed triangulation and I get the error > > error: no matching function for call to > ‘dealii::parallel::distributed::Triangulation<2>::Triangulation(ompi_communicator_t*&, > > deali

Re: [deal.II] fixing one component of solution to the same value

2017-04-20 Thread Daniel Arndt
Rajat, It seems that I confused lines and did not express in the code what I wrote above: You have to add that additional index also when initializing the sparsity pattern, i.e. std::cout << " constraints printed "

Re: [deal.II] fixing one component of solution to the same value

2017-04-20 Thread Daniel Arndt
Rajat, What is happening here is that you try to create constraints that include DoFs that are not element of the IndexSet you provided to the DynamicSparsityPattern object. Therefore, all the entries for your "fixed" DoF are ignored if it is not already part of the locally relevant DoFs. Have

Re: [deal.II] Re: imposing boundary conditions for a three-fields formulation

2017-04-20 Thread Daniel Arndt
Alberto, Now I understand your concern. The boolean flag that is passed as the final > parameter to MatrixTools::apply_boundary_values > > > determines whether column elimination is perfo

[deal.II] Re: QProjector::project_to_face and Gauss Lobatto

2017-04-19 Thread Daniel Arndt
vganpat, I am trying to solve a problem that has both the volume integral and a > surface integral. > You would normally just create a quadrature rule for the volume and the surface integral separately. > If I am using a higher order polynomial approximation and use Gauss > Lobatto quadratu

Re: [deal.II] Bug? - FETools::extrapolate changes behavior in 8.5

2017-04-17 Thread Daniel Arndt
Winni, This should be fixed upstream now. Have a look at PR #4256 [1]. Best, Daniel [1] https://github.com/dealii/dealii/pull/4256 -- 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

Re: [deal.II] Re: Meshworker in dim=2, spacedim = 3

2017-04-17 Thread Daniel Arndt
Andrea, This should be fixed upstream now. Have a look at PR #4265 [1]. Best, Daniel [1] https://github.com/dealii/dealii/pull/4265 -- 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

[deal.II] Re: Unable to download dealii-8.4.1 for Mac

2017-04-08 Thread Daniel Arndt
Ana, I can't confirm your problem. Downloading works without issues. What browser are you using? Do you get any warnings? Best, Daniel Am Samstag, 8. April 2017 16:39:34 UTC+2 schrieb Ana Marija: > > Hi, > > For a few days I am unable to download installation for MAC, it always > fails around

[deal.II] Re: Finite Element Method for Two Phase Flow

2017-04-07 Thread Daniel Arndt
Sumedh, In my project I am modeling two-phase flow using phase-field model (an > interface capturing method). Now I am done with first draft of my code and > I am facing the well-known issue of 'spurious currents in two-phase flow > using FEM' (paper 1 >

[deal.II] Re: Inhomogeneous Dirichlet bounday conditions with Raviart-Thomas (RT) elements

2017-04-07 Thread Daniel Arndt
Sumedh, I intend to use RT elements for my fluid flow problem and the test case > (2D) is shear flow. Consequently the I need to apply constant shear/sliding > velocity (u_x = shear_velocity, u_y = 0) at top and bottom boundaries and > velocities of form u_y = 0, u_x = y*shear_velocity for the

[deal.II] Re: fe_enriched and step-47

2017-04-06 Thread Daniel Arndt
David, > Hopefully someone get to finish step-47 with XFEM. I am really interested > in digging there and I put it on my own TODO list. > I don't know if Wolfgang, the author of the tutorial, plan to finish it. > Maybe we can team up here. > step-47 seems to be completed in the paper On the im

[deal.II] Re: Avoid holding matrices in vector for MeshWorker

2017-03-26 Thread Daniel Arndt
Franco, You are right that there is no matrix assembler class that accepts an AnyData object. I have seen that MeshWorker with the MatrixSimple assembler has an > initialize member that needs a vector of matrices. However that isn't > really good for my case, as I'd like to assign ownership of

[deal.II] Re: New: step-57

2017-03-26 Thread Daniel Arndt
Jack, Is it possible to extend your code to time dependent Navier-Stokes >> equations? >> >> I want to solve the unsteady Navier-Stokes equations using the >> *Vector-Valued* method, but I did not get any good idea from the >> tutorial examples (step-22, step-32, etc.) for Stokes flow. >> > The

<    1   2   3   4   5   6   >