[deal.II] How to use ManifoldMapping

2016-05-16 Thread Praveen C
Dear all I am solving pde on sphere and want to use MappingManifold My mesh is generated like this. Point center(0.0, 0.0, 0.0); GridGenerator::hyper_sphere(triangulation, center, Radius); static SphericalManifold surface_description; triangulation.set_all_manifold_ids(0)

Re: [deal.II] How to use ManifoldMapping

2016-05-16 Thread Praveen C
some fun stuff lately… > > Though, I can help you with implementing fixes, if you are willing to > help… :) > > L. > > > On 16 May 2016, at 10:35, Praveen C wrote: > > > > Dear all > > I am solving pde on sphere and want to use MappingManifold > > &g

Re: [deal.II] How to use ManifoldMapping

2016-05-16 Thread Praveen C
normal vectors (which lie in tangent plane) be correct at the junction of the two manifolds ? The RotatedSphericalManifold is attached. Thanks praveen On Mon, May 16, 2016 at 4:20 PM, luca.heltai wrote: > > > On 16 May 2016, at 12:37, Praveen C wrote: > > > > Dear Luca &g

Re: [deal.II] How to use ManifoldMapping

2016-05-16 Thread Praveen C
difference seems rather large. Best praveen On Mon, May 16, 2016 at 9:08 PM, Praveen C wrote: > Dear Luca > > I need a Manifold<2,3> object but I could not succeed in composing > SphericalManifold with a rotation. There were many dimensions involved in > the composition which

Re: [deal.II] How to use ManifoldMapping

2016-05-16 Thread Praveen C
als VS quadrature points? > > L. > > > > On 17 May 2016, at 8:43, Praveen C wrote: > > > > Dear all > > > > There is also a large difference in face normal vectors which I need > since I am using a DG scheme for pde on sphere. > > > &g

Re: [deal.II] How to use ManifoldMapping

2016-05-17 Thread Praveen C
, 2016 at 12:30 PM, luca.heltai wrote: > Then can you verify which ones are correct, by taking the scalar product > with the quadrature points (assuming a sphere centered at the origin), and > check which ones are zero (IF they are zero)? > > Best, > > L. > > > > O

Re: [deal.II] How to use ManifoldMapping

2016-05-21 Thread Praveen C
value while MappingQ(9) gives small values. Best praveen On Fri, May 20, 2016 at 11:10 AM, Praveen C wrote: > Dear Luca > > I have created a simple test case to show the problem with MappingManifold > for sphere. > > Please see attached pdf. The code is also attached. > >

Re: [deal.II] How to use ManifoldMapping

2016-05-21 Thread Praveen C
nto this. We'll let you know. :-) > > Luca > > On 21 mag 2016, at 12:34, Praveen C wrote: > > Some additional info about the problem I am facing. In the test I sent > last, I used a divergence-free vector field v on the sphere. > > Both the quantities > > integ

[deal.II] On the use of MappingFEField

2016-05-29 Thread Praveen C
Dear all I have problems involving airfoil geometry where the cells have high aspect ratio in the boundary layer. Due to this, it is not enough to just use curved boundaries but the interior faces also need to be curved. See the attached figure gridq1.pdf I have implemented a method based on wins

[deal.II] Reuse factorization in Trilinos direct solver

2016-06-20 Thread Praveen C
Hi I want to use the direct solver MUMPS via Trilinos. I need to solve the same matrix problem repeatedly. How can I reuse the LU factorization ? In SparseDirectUMFPACK, calling vmult allows me to solve many problems with same factorization. Is such a thing possible with TrilinosWrappers::Solver

[deal.II] Read serial vector into a parallel vector

2016-06-20 Thread Praveen C
Hello I solve a PDE in serial and save the solution to file. Is there a way to now read this solution into a TrilinosWrappers::MPI::Vector object ? Thanks praveen -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https://groups.google.com/d/forum/

Re: [deal.II] Re: Read serial vector into a parallel vector

2016-06-20 Thread Praveen C
Hello Daniel I have a normal Triangulation and I solve on this using a Vector. I could save this to file calling Vector::print. Is it now possible to read this into a TrilinosWrappers::MPI::Vector ? If not, what other option do I have to achieve this result. Thanks praveen On Mon, Jun 20, 2016

Re: [deal.II] Re: Reuse factorization in Trilinos direct solver

2016-06-20 Thread Praveen C
; Uwe > > > On Monday, June 20, 2016 at 3:48:56 PM UTC+2, Praveen C wrote: >> >> Hi >> >> I want to use the direct solver MUMPS via Trilinos. I need to solve the >> same matrix problem repeatedly. How can I reuse the LU factorization ? >> >&g

[deal.II] Adding dirichlet values to ConstraintMatrix

2016-06-22 Thread Praveen C
Dear all I have created a std::map boundary_values; I want to add this to a ConstraintMatrix but I could not find any function to do this. >From the documentation, I could do for each dirichlet dof { add_line(...) set_inhomogeneity(...) } Is this the only way to accomplish what I want ? I a

Re: [deal.II] Adding dirichlet values to ConstraintMatrix

2016-06-23 Thread Praveen C
nts.add_line (pair.first); constraints.set_inhomogeneity (pair.first, pair.second); } } On 23-Jun-2016, at 11:23 AM, Wolfgang Bangerth wrote: On 06/23/2016 12:48 AM, Praveen C wrote: I have created a std::map boundary_values; I want to add this to a ConstraintMatrix but I could

[deal.II] TrilinosWrappers::SolverDirect

2016-06-23 Thread Praveen C
Dear all I am using the new TrilinosWrappers::SolverDirect which allows two step solution: initialize and solve. Since I want to calculate LU decomposition only once, I do something like this static int first_time = 1; static TrilinosWrappers::SolverDirect::AdditionalData data (fals

[deal.II] On using TrilinosWrappers::SolverDirect

2016-06-23 Thread Praveen C
Dear all I am using the new TrilinosWrappers::SolverDirect which allows two step solution: initialize and solve. Since I want to calculate LU decomposition only once, I do something like this static int first_time = 1; static TrilinosWrappers::SolverDirect::AdditionalData data (fals

Re: [deal.II] On using TrilinosWrappers::SolverDirect

2016-06-24 Thread Praveen C
pointer to your solver in your main class, and create and > initialise it when (first_time == true), and then it gets removed when the > class destructor is called. > > > > J-P > > > > On Friday, June 24, 2016 at 8:38:59 AM UTC+2, Praveen C wrote: > > Dear all >

[deal.II] On the use of MappingFEField

2016-06-24 Thread Praveen C
of the exception was: ExcInUse (counter, object_info->name(), infostring) Additional Information: Object of class N6dealii6VectorIdEE is still used by 1 other objects. Thanks praveen On 30-May-2016, at 11:32 AM, Praveen C wrote: Dear all I have problems involving airfoil geometry where

Re: [deal.II] On the use of MappingFEField

2016-06-24 Thread Praveen C
2, 2> const&, dealii::TrilinosWrappers::MPI::Vector const&, dealii::ComponentMask)", referenced from: _main in main.cc.o Thanks praveen On 25-Jun-2016, at 10:51 AM, Wolfgang Bangerth wrote: On 06/24/2016 11:57 PM, Praveen C wrote: MappingFEField map(dh_euler, euler_

[deal.II] Re: On the use of MappingFEField

2016-06-25 Thread Praveen C
l sequence of the exception was: ExcInUse (counter, object_info->name(), infostring) Additional Information: Object of class N6dealii6VectorIdEE is still used by 1 other objects. Thanks praveen > On 30-May-2016, at 11:32 AM, Praveen C wrote: > > Dear all > > I have problems i

Re: [deal.II] Re: On the use of MappingFEField

2016-06-27 Thread Praveen C
Hello It would be nice if the two threads can be merged. There were no replies to my original questions. Thanks praveen On Mon, Jun 27, 2016 at 6:15 PM, Denis Davydov wrote: > I suppose this is a duplicate post and can be deleted? > > > On Monday, May 30, 2016 at 8:02:06 AM UTC+

Re: [deal.II] Question step5 in the lectures(about Coefficient...)

2016-07-05 Thread Praveen C
Hi In value_list function, you can get (x,y) like this double x = points[i][0]; double y = points[i][1]; Best praveen On Wed, Jul 6, 2016 at 12:13 PM, wrote: > Hi, > > I am trying to study step-5.cc. But I have some problem... > > I would like to make Coefficient 1/x (As you know, In step-5.c

[deal.II] SphericalManifold and accuracy problem

2016-08-09 Thread Praveen C
Hello I am trying the SphericalManifold in latest git version. I observe accuracy issues with this. E.g., I compute surface area of sphere using degree k mapping and (k+1)-point GaussLobatto quadrature. Unit sphere with 384 surface cells obtained from GridGenerator::hyper_sphere after 3 refineme

Re: [deal.II] SphericalManifold and accuracy problem

2016-08-10 Thread Praveen C
t work. This may be > related to the introduction of MappingQGeneric, but I’m just shooting in > the dark. > > If you are willing to help, we could try to identify what the problem > could be... > > Bets, > > Luca. > > > On 10 Aug 2016, at 7:03, Praveen C wrot

[deal.II] Does MappingFEField apply to all cells ?

2016-08-19 Thread Praveen C
Hello I am using MappingFEField to get high order meshes which I construct by solving Winslow equations. I set initial condition and save it to file with 3 patches. As the figure shows, it seems to me that the MappingFEField is used only for the cells adjacent to the boundary. Is this what is hap

Re: [deal.II] Does MappingFEField apply to all cells ?

2016-08-22 Thread Praveen C
Thanks Wolfgang. I should have checked the built_patches function. It works fine if I give the third argument. But now I have to find the real reason why my code is crashing with MappingFEField :-( Best praveen On Mon, Aug 22, 2016 at 6:36 PM, Wolfgang Bangerth wrote: > > Praveen, > > I am usin

[deal.II] Some bug with deal.II from git

2016-08-22 Thread Praveen C
Dear all I have convergence problem with one of my codes using deal.II from git. Using the Aug 4 version (commit ed1bdc6fc1931a664bc30920f66f054907a49cce) the code converges to 1.0e-10 in 20 iterations. Using the Aug 16 version (commit 2ca845c83a1bceb8d1d09df2ee729b4ec6d5547b) does not converge,

Re: [deal.II] Some bug with deal.II from git

2016-08-23 Thread Praveen C
So it looks like the problem is with commit d1e3ffcaf6733e7d8509d93785b1f9e2b16a977e Author: Luca Heltai Date: Tue Jul 12 12:39:30 2016 +0200 Added get_new_point with two points and a weight. I will try to send my code which is affected by the "bug", but it may not be very simple. Best p

Re: [deal.II] Some bug with deal.II from git

2016-08-23 Thread Praveen C
$ 20accuracy$20problem%7Csort:relevance/dealii/o33ApWoDnPQ/4MGY6SjMBQAJ Best praveen On Tue, Aug 23, 2016 at 10:36 PM, Praveen C wrote: > So it looks like the problem is with > > commit d1e3ffcaf6733e7d8509d93785b1f9e2b16a977e > Author: Luca Heltai > Date: Tue Jul 12 12:3

Re: [deal.II] Some bug with deal.II from git

2016-08-23 Thread Praveen C
::map_dofs_to_support_points ??? Thanks praveen On Wed, Aug 24, 2016 at 10:06 AM, Praveen C wrote: > Dear all > > I have included below an example code which converges with > > commit ed1bdc6fc1931a664bc30920f66f054907a49cce > > but fails to converge with > > commit d1e3ffcaf6733e7d8509

Re: [deal.II] Some bug with deal.II from git

2016-08-25 Thread Praveen C
I have created this issue https://github.com/dealii/dealii/issues/3013 Thanks praveen On Wed, Aug 24, 2016 at 9:55 PM, Wolfgang Bangerth wrote: > On 08/24/2016 12:17 AM, Praveen C wrote: > >> Here is some info which might help. >> >> I use FE_Q with GaussLobatto nod

Re: [deal.II] Re: PETScWrappers::MPI::Vector Vs parallel::distributed::Vector

2016-08-28 Thread Praveen C
Hello This is more of a question. There is this function PETScWrappers::VectorBase::extract_subvector_to http://www.dealii.org/developer/doxygen/deal.II/classPETScWrappers_1_1VectorBase.html#ae0f3a2b5fc8e2201237fad86ae69142e which should give faster access to the vector elements ??? >From what

[deal.II] Re: Creating my own constraints matrix for applying dirichlet bc

2016-09-05 Thread Praveen C
So if I loop over all non-artificial cells instead of locally owned cells to build the dirichlet map, then it seems to work correctly. Best praveen On Mon, Sep 5, 2016 at 7:37 PM, Praveen C wrote: > Dear all > I have to create a constraint matrix to apply dirichlet bc by taking the &g

[deal.II] Creating my own constraints matrix for applying dirichlet bc

2016-09-05 Thread Praveen C
Dear all I have to create a constraint matrix to apply dirichlet bc by taking the values from an existing solution (in vector “x" below) on the same mesh. for(typename DoFHandler::active_cell_iterator cell = dof_handler.begin_active(), endc = dof_handler.end();

[deal.II] FE_TraceQ using GaussLobatto nodes

2016-09-06 Thread Praveen C
Dear all The documentation says that GaussLobatto node-based FE_TraceQ will be implemented in future. Is there any estimate on when this will be available ? In Interior Embedded DG (IEDG) scheme, you need trace spaces which are continuous on interior faces but discontinuous on boundary faces. Is

Re: [deal.II] FE_TraceQ using GaussLobatto nodes

2016-09-07 Thread Praveen C
Hello Martin, On Wed, Sep 7, 2016 at 11:28 AM, Martin Kronbichler < kronbichler.mar...@gmail.com> wrote: > Dear Praveen, > > > > The documentation says that GaussLobatto node-based FE_TraceQ will be > > implemented in future. Is there any estimate on when this will be > > available ? > The docume

Re: [deal.II] FE_TraceQ using GaussLobatto nodes

2016-09-08 Thread Praveen C
Hello Martin When I use FE_TraceQ and am setting initial condition with VectorTools::interpolate, I get this error An error occurred in line <127> of file in function void dealii::VectorTools::interpolate(const Mapping &, const DoFHa

Re: [deal.II] FE_TraceQ using GaussLobatto nodes

2016-09-08 Thread Praveen C
Hello Martin > You are right, we should allow for interpolation of initial condition. We > also allow this for FE_FaceQ. I will soon open a PR. On the other hand, we > will probably not be able to project onto FE_TraceQ with our tools because > this element does not define basis functions inside

Re: [deal.II] Interpolating values of the neighbor cells in DG

2016-09-19 Thread Praveen C
Hello Jiaqi I was interested in this some years back though I didnt pursue it after some initial attempt. See this https://groups.google.com/forum/m/?hl=en-GB#!topic/dealii/gaongNBSXfY I tried writing an fespace based on FE_DGPNonparametric which does not use a mapping and the shape functions a

Re: [deal.II] Interpolating values of the neighbor cells in DG

2016-09-19 Thread Praveen C
On Tue, Sep 20, 2016 at 9:34 AM, Jiaqi ZHANG wrote: > Hello Praveen, > > Thank you so much. I am wondering if you could tell me which > > limiters you used, because if it is too hard for me to implement > > this limiter, I will have to try other ones. I am a newbie to C++, > > but will try to rea

Re: [deal.II] Re: Can we say that the higher order method, the more accurate?

2016-09-20 Thread Praveen C
On Tue, Sep 20, 2016 at 7:49 PM, JAEKWANG KIM wrote: > Can I ask more about "the limits of our implementation of our quadrature > formulas?". > I wonder when it usually happens. > > > Once I calculated drag coefficient, with Q1, my error is 10% compare to > exact solution. > However, I can 1.7% e

[deal.II] Proper use of CompositionManifold

2016-09-21 Thread Praveen C
Dear all I am trying to compose two manifolds. I want to apply a 90 deg rotation about x-axis to PolarManifold to obtain description of surface of sphere and thereby avoid the poles. So I try something like this static PolarManifold<2,3> sphere; static FunctionManifold<3,3,3> rota

Re: [deal.II] Re: Input Q2 element generated by Gmsh using Gridin

2016-09-21 Thread Praveen C
Having curved boundaries alone is not sufficient sometimes. One would like to use curved elements in the interior also. It would be very useful if one could read high order meshes, e.g., from gmsh. The extra nodes can be used to create an euler vector that can be used in a MappingFEField. There ha

[deal.II] Re: Proper use of CompositionManifold

2016-09-21 Thread Praveen C
Hello I think I understand this better after reading the code. Here is my attempt static const PolarManifold<2,3> sphere; static const FunctionManifold<3,3,3> rotate("x,-z,y","x,z,-y"); static CompositionManifold<2,3,2,3,3,3> surface(sphere, rotate); I use dim=2 The dimensi

[deal.II] Re: Proper use of CompositionManifold

2016-09-21 Thread Praveen C
,2,3> rotated_sphere(sphere, rotate); Thanks praveen On Thu, Sep 22, 2016 at 10:03 AM, Praveen C wrote: > Hello > > I think I understand this better after reading the code. Here is my attempt > > static const PolarManifold<2,3> sphere; > > static const Fu

Re: [deal.II] Re: Proper use of CompositionManifold

2016-09-22 Thread Praveen C
Thanks Luca. I have been looking at tests also. For CompositionManifold, if H = CompositionManifold(F, G) then H_pullback = F_pullback * G_pullback H_pushforward = G_pushforward * F_pushforward I think adding this to documentation will improve the description. Also this line dim1 The dimens

[deal.II] Re: PolarManifold vs SphericalManifold

2016-09-22 Thread Praveen C
Hello This is a bit old question, and I would like to pose it again. The first post is here https://groups.google.com/d/msg/dealii/pB-s0JELJy0/2vBXef_IBQAJ I am using PolarManifold and a 90 deg rotated PolarManifold to cover the surface of sphere. As I posted in this thread, some cells at the c

Re: [deal.II] Re: PolarManifold vs SphericalManifold

2016-09-22 Thread Praveen C
Dear Luca I wanted to use MappingManifold for sphere, but it looks like this is not possible either with PolarManifold or SphericalManifold. I am doing this for a shallow water model on sphere, where I want to do long time integration, and look at conservation of mass, energy, etc. Having an exac

[deal.II] FEValues and get_function_values when support points = quadrature points

2016-09-30 Thread Praveen C
Dear all In many cases, we use same nodes as support points for FE space and quadrature. In this case, FEValues.get_function_values can just read off the function values without performing a sum over all basis functions. Does FEValues actually recognise and make this optimization ? If not, is it p

Re: [deal.II] FEValues and get_function_values when support points = quadrature points

2016-09-30 Thread Praveen C
AM, Wolfgang Bangerth wrote: > On 09/30/2016 08:59 PM, Praveen C wrote: > >> >> In many cases, we use same nodes as support points for FE space and >> quadrature. In this case, FEValues.get_function_values can just read off >> the >> function values without perfo

[deal.II] Accuracy of shape function gradients

2016-10-04 Thread Praveen C
Dear all While a solving a conservation law with DG, I find that total mass is not conserved. To get total mass conservation, we need sum_(i=0,1,...ndofs-1) grad(phi_i(xq, yq, zq)) = 0 where phi_i are shape functions and ndofs = fe.dofs_per_cell and above equation must hold at every quadrature

[deal.II] Re: Accuracy of shape function gradients

2016-10-04 Thread Praveen C
Please ignore my message. I implemented the fix for grad(phi_i) within my code but that still does not solve my problem. Best praveen On Wed, Oct 5, 2016 at 10:42 AM, Praveen C wrote: > Dear all > > While a solving a conservation law with DG, I find that total mass is not > conse

[deal.II] Re: Problem with get_back_interpolation_matrix when dim=2, spacedim=3

2016-10-19 Thread Praveen C
ould give me the same matrix as in the case dim=2, spacedim=3, right ??? Best praveen On Wed, Oct 19, 2016 at 7:22 PM, Praveen C wrote: > Dear all > > I am doing this > >const FE_DGQArbitraryNodes fe(QGauss<1 > >(degree+1)); > > filter_matrix

[deal.II] Problem with get_back_interpolation_matrix when dim=2, spacedim=3

2016-10-19 Thread Praveen C
Dear all I am doing this const FE_DGQArbitraryNodes fe(QGauss<1>(degree+1)); filter_matrix.reinit(fe.dofs_per_cell, fe.dofs_per_cell); const FE_DGQArbitraryNodes fe1(QGauss<1>(degree)); FETools::get_back_interpolation_matrix(fe, fe1, filter_matrix); but this give

[deal.II] Alternative to local_range

2016-10-22 Thread Praveen C
Dear all local_range is marked deprecated http://www.dealii.org/developer/doxygen/deal.II/classLinearAlgebra_1_1distributed_1_1Vector.html#ade4b13c22b96f11d6652bf2271602180 How can I get the same info without using this function ? Thanks praveen -- The deal.II project is located at http://www

Re: [deal.II] Alternative to local_range

2016-10-22 Thread Praveen C
I have an IndexSet of locally_owned_dofs and I want to know the starting index. praveen On Sun, Oct 23, 2016 at 9:56 AM, Wolfgang Bangerth wrote: > On 10/22/2016 09:41 PM, Praveen C wrote: > >> >> local_range is marked deprecated >> >> http://www.dealii

[deal.II] Trouble with VisIt 2.11

2016-10-22 Thread Praveen C
When I try to view a HDF5/xdmf file with VisIt 2.11, it reads the file, but when I try to plot a pseudocolor, I get this error engine_ser(3188,0x7fff7a57f000) malloc: *** error for object 0x7fba9b07bd10: pointer being freed was not allocated *** set a breakpoint in malloc_error_break to debug a

Re: [deal.II] Re: How to apply boundary values for a particular point on the boundary instead of the whole boundary surface

2016-10-25 Thread Praveen C
Hi You can construct an interpolation of your data and use it for boundary condition, see http://www.dealii.org/developer/doxygen/deal.II/classFunctions_1_1InterpolatedUniformGridData.html http://www.dealii.org/developer/doxygen/deal.II/classFunctions_1_1InterpolatedTensorProductGridData.html B

Re: [deal.II] Re: Trouble with VisIt 2.11

2016-10-26 Thread Praveen C
Hello Daniel I have put the solution file here https://www.dropbox.com/s/qdich18ox8rlx9r/sol.tgz?dl=0 It displays with v2.10.3 but not v2.11 The deal.II code to write this file is given below. Best praveen template void ConservationLaw::output_results_xdmf () { #ifdef TIMER TimerOutpu

Re: [deal.II] Re: Trouble with VisIt 2.11

2016-11-01 Thread Praveen C
On Thu, Oct 27, 2016 at 12:53 PM, 'Uwe Köcher' via deal.II User Group < dealii@googlegroups.com> wrote: > Dear Praveen, > > I do not use visit, but deal.II + hdf5 + paraview. Your attached file can > be opened with paraview. > But this does not mean, that we have a correct implementation within >

[deal.II] deal.II on youtube and twitter

2016-11-02 Thread Praveen C
Dear all I sometimes upload videos/pictures of solutions obtained with deal.II on youtube and twitter. I am tagging with #dealii on twitter. https://twitter.com/search?q=%23dealii I dont know how to properly tag videos on youtube. I have some videos here made with deal.II https://www.youtube.co

Re: [deal.II] Re: Trouble with VisIt 2.11

2016-11-02 Thread Praveen C
, Praveen C wrote: > > On Thu, Oct 27, 2016 at 12:53 PM, 'Uwe Köcher' via deal.II User Group < > dealii@googlegroups.com> wrote: > >> Dear Praveen, >> >> I do not use visit, but deal.II + hdf5 + paraview. Your attached file can >> be opened with paravie

Re: [deal.II] maximum value of solution

2016-11-06 Thread Praveen C
Hi You are finding maximum at the quadrature points of QGauss(2). When solution is saved, it is evaluated at uniformly distributed points by build_patches. So the two values may differ. To get same values as in your visualization, you can use a QTrapez and QIterated. This combination is explain

[deal.II] Relation of FE_Q support points and quadrature points

2016-11-23 Thread Praveen C
Dear all Suppose I have FE_Q fe(degree); QGaussLobatto quad(degree+1); Within a cell, I get FEValues fe_values(quad, update_quadrature_points); fe_values.reinit(cell); cell->get_dof_indices(local_dof_indices); Then can I assume that, in the current cell, solution(local_dof_indices[q]) is the

Re: [deal.II] Relation of FE_Q support points and quadrature points

2016-11-23 Thread Praveen C
rt_points() > > https://www.dealii.org/8.4.1/doxygen/deal.II/classFiniteElement.html# > aa0169a82a73318973ad38e5785acdb27 > > If you want to use this as a quadrature, you have to make sure that the > weights are in the right order. > > L. > > > > On 23 Nov 2016, at 10

Re: [deal.II] Relation of FE_Q support points and quadrature points

2016-11-23 Thread Praveen C
eak; > } > Assert(w[i] == -1.0, ExcInternalError(“Did not find the point!”)); > } > > Quadrature new_quad(q,w); > > > Now you are sure that the quadrature new_quad is doing what you asked for. > > L. > > > On 23 Nov 2016, at 11:04, Praveen C wrote: &

[deal.II] Interpolating p::d::Vector

2016-11-23 Thread Praveen C
Dear all I have an FE_Q space and a ghosted p::d::Vector. When I call VectorTools::interpolate on this, I get this error An error occurred in line <679> of file in function void dealii::LinearAlgebra::distributed::Vector::compress_finish(::dealii::VectorOperation::values) The violated cond

Re: [deal.II] Interpolating p::d::Vector

2016-11-23 Thread Praveen C
Hello Martin I am patching many charts to define a manifold to cover the sphere. I use MappingManifold. I suspect at the interface of two charts, which also coincides with the mesh partition boundary, there may be some round off error. Best praveen On Wed, Nov 23, 2016 at 7:12 PM, Martin Kronbic

[deal.II] deal.II cmake stuck at "Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG"

2016-12-15 Thread Praveen C
Dear all I am trying to install on a new machine running opensuse tumbleweed. I installed packages using spack $ spack find *==>* 37 installed packages. -- linux-opensuse20161212-x86_64 / gcc@6 arpack-ng@3.4.0 m4@1.4.17 pkg-config@0.29.1 autoconf@2

[deal.II] Re: deal.II cmake stuck at "Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG"

2016-12-15 Thread Praveen C
Additionally I added Fortran compiler and fixed "suitesparse" to "suite-sparse", but I am still stuck at the same place as before. Should I use "Filesystem View" to compile my own dealii with spack packages ? If I install dealii@develop using spack, how do I update dealii in future ? Thanks prav

Re: [deal.II] Re: deal.II cmake stuck at "Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG"

2016-12-16 Thread Praveen C
. Best praveen On Fri, Dec 16, 2016 at 6:28 PM, Denis Davydov wrote: > > > On Friday, December 16, 2016 at 4:34:29 AM UTC+1, Praveen C wrote: >> >> Additionally I added Fortran compiler and fixed "suitesparse" to >> "suite-sparse", but I am still st

Re: [deal.II] Re: deal.II cmake stuck at "Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG"

2016-12-17 Thread Praveen C
On Sat, Dec 17, 2016 at 5:26 PM, Denis Davydov wrote: > Alternative, is to add the view to your path, i.e. > > PATH=${DEAL_II_VIEW}/bin:${PATH} > > then > > -DCMAKE_C_COMPILER="mpicc" > > would also be ok. > I used instructions on wiki like this DEAL_II_VIEW=/home/soft cmake \ -DCMAKE_FIND_

Re: [deal.II] Re: deal.II cmake stuck at "Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG"

2016-12-17 Thread Praveen C
no log/error file so far. I attach spack output. Best praveen On Sat, Dec 17, 2016 at 5:41 PM, Denis Davydov wrote: > > On 17 Dec 2016, at 12:59, Praveen C wrote: > > I used instructions on wiki like this > > DEAL_II_VIEW=/home/soft > > cmake \ > -DCMAKE_FIND_

Re: [deal.II] Re: deal.II cmake stuck at "Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG"

2016-12-17 Thread Praveen C
After 45 min, cmake is still at -- Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG so I killed it. Let me know if you want me to wait longer with hope of getting some error message. Thanks praveen -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see

Re: [deal.II] Re: deal.II cmake stuck at "Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG"

2016-12-17 Thread Praveen C
On Sat, Dec 17, 2016 at 8:41 PM, Denis Davydov wrote: > That looks like something is wrong in deal.II configuration tests. > Correct me if I am wrong, but 8.4.2 installs ok for you with Spack but the > current @develop fails, > so the changes must have been introduced after 8.4.2 release. > > Yes

Re: [deal.II] Re: deal.II cmake stuck at "Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG"

2016-12-18 Thread Praveen C
_SETUP, then start > putting messages in > https://github.com/dealii/dealii/blob/master/cmake/ > macros/macro_check_compiler_setup.cmake > > That should eventually lead to to a single line which hangs on your system. > > Regards, > Denis. > > > On Saturday, December 17

Re: [deal.II] Re: deal.II cmake stuck at "Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG"

2016-12-19 Thread Praveen C
alues of all > flags and if they make any sense. > > Kind regards, > Denis > > On 19 Dec 2016, at 15:08, Praveen C wrote: > > Looking at "ps -ef" I can see which process cmake is stuck at. I have > attached the currently running processes during "Perform

Re: [deal.II] Re: deal.II cmake stuck at "Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG"

2016-12-19 Thread Praveen C
On Mon, Dec 19, 2016 at 8:05 PM, Denis Davydov wrote: > spack install dealii@develop~gsl > > and also > > spack install dealii@develop~python+mpi^boost+python > No luck with both of these, same problem as before. Best praveen -- The deal.II project is located at http://www.dealii.org/ For mai

Re: [deal.II] Re: deal.II cmake stuck at "Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG"

2016-12-19 Thread Praveen C
dealii/dealii/commits/master/cmake/macros/macro_check_compiler_setup.cmake > and can be a rough guess if you don’t want to do bisection blindly between > the current devevelop and 8.4.2 (which is in dealii-8.4 branch). > > Kind regards, > Denis > > On 19 Dec 2016, at 17:02, Pravee

Re: [deal.II] Re: deal.II cmake stuck at "Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG"

2016-12-19 Thread Praveen C
I replace mpic++ with /usr/bin/g++ but the command goes on forever. mpi is also from spack and I have only one mpi on this machine. gcc/g++ are from suse. Best praveen On Mon, Dec 19, 2016 at 10:39 PM, Wolfgang Bangerth wrote: > On 12/19/2016 07:26 AM, Praveen C wrote: > >> >&

Re: [deal.II] Re: deal.II cmake stuck at "Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG"

2016-12-19 Thread Praveen C
I removed all the libraries and do /home/spack/opt/spack/linux-opensuse20161217-x86_64/gcc-6/openmpi-2.0.1-asdjmd22cnyktv2athcx3ouhrozknk22/bin/mpic++ -DDEAL_II_HAVE_USABLE_FLAGS_DEBUG -pedantic -fPIC -Wall -Wextra -Wpointer-arith -Wwrite-strings -Wsynth -Wsign-compare -Wswitch -Woverloaded-virt

Re: [deal.II] Re: deal.II cmake stuck at "Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG"

2016-12-20 Thread Praveen C
27;/home/spack/opt/spack/linux-opensuse20161217-x86_64/gcc-6/openmpi-2.0.1-asdjmd22cnyktv2athcx3ouhrozknk22/include' '-pthread' '-L/home/spack/opt/spack/linux-opensuse20161217-x86_64/gcc-6/hwloc-1.11.4-7osold4o3nkppdzghwo5fjlgmxpsqb4h/lib' '-L/home/spack/opt/spack/linux-

Re: [deal.II] Re: deal.II cmake stuck at "Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG"

2016-12-20 Thread Praveen C
Denis, I observe that dealii@8.4.2 and dealii@develop install their own separate Boost, same version but maybe different variants/flags. Trilinos also needs Boost. Could there be some issue with dependencies like Boost ? Best praveen -- The deal.II project is located at http://www.dealii.org/ Fo

Re: [deal.II] Re: deal.II cmake stuck at "Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG"

2016-12-20 Thread Praveen C
Hello Denis I am not able to do either spack install dealii@develop~python or spack install dealii@8.4.2 It fails at Boost *==>* Using cached archive: /home/spack/var/spack/cache/boost/boost-1.62.0.tar.bz2 *==>* Already staged boost-1.62.0-iha4a5u6hustzchy6iglss5gbz2ujrvc in /home/spack/var/

Re: [deal.II] Re: deal.II cmake stuck at "Performing Test DEAL_II_HAVE_USABLE_FLAGS_DEBUG"

2016-12-20 Thread Praveen C
Hi Praveen, > > On 20 Dec 2016, at 13:52, Praveen C wrote: > > Hello Denis > > I am not able to do either > > spack install dealii@develop~python > > or > > spack install dealii@8.4.2 > > It fails at Boost > > *==>* Using cached archive: /ho

[deal.II] Workstream, number threads

2016-12-28 Thread Praveen C
Dear all I use WorkStream in my code. I initialize like this unsigned int n_threads = 1; Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv, n_threads); But when I run this code, each process is using 1700% of CPU. The code does not progress in its iterations also. What am I doing

Re: [deal.II] Re: Workstream, number threads

2016-12-29 Thread Praveen C
Hello Daniel I recompiled dealii without threads. When I run step-40 single process ./step-40 I see upto 2000% cpu usage during cycle 7 when viewed in top. Best praveen On Thu, Dec 29, 2016 at 3:51 PM, Daniel Arndt < d.ar...@math.uni-goettingen.de> wrote: > Praveen, > > unsigned int n_thread

Re: [deal.II] Re: Workstream, number threads

2016-12-29 Thread Praveen C
xport OMP_NUM_THREADS=1"). deal.II applies > threading on a higher level and a threaded BLAS is counter-productive in > 98% of cases. > > Best, > Martin > > On 29.12.2016 11 <0291%20220%201611>:30, Praveen C wrote: > > Hello Daniel > > I recompiled dealii w

[deal.II] Library file sizes

2017-01-10 Thread Praveen C
I noticed that on my linux computer, the deal.II debug library size is rather large $ du -sh * 60K cmake 0 libdeal_II.g.so 1.3G libdeal_II.g.so.8.5.0-pre 0 libdeal_II.so 138M libdeal_II.so.8.5.0-pre Is this normal ? Best praveen -- The deal.II project is located at http://www.dealii.org/

[deal.II] Find dofs supported on each face and quadrature point

2017-01-12 Thread Praveen C
Hello My fe space is FE_DGQArbitraryNodes (QGauss<1>(degree+1)) For face quadrature I use QGauss(degree+1) At each face quadrature point, there are only (degree+1) dofs which are supported there. I would like to find this information. I have written a function as below which computes Tabl

Re: [deal.II] Find dofs supported on each face and quadrature point

2017-01-12 Thread Praveen C
Thanks a lot Martin for finding the bug. Since I was only doing 2d so far, I had not hit that bug. Best praveen On Thu, Jan 12, 2017 at 2:16 PM, Martin Kronbichler < kronbichler.mar...@gmail.com> wrote: > Dear Praveen, > > No, we do not have information about these properties available in the >

Re: [deal.II] Examples makefile

2017-01-15 Thread Praveen C
It should be there in detailed.log which is generated after cmake is run. Best praveen On Mon, Jan 16, 2017 at 8:48 AM, Victor Eijkhout wrote: > > On Jan 14, 2017, at 4:54 PM, Jean-Paul Pelteret > wrote: > > you could instead just not build Trilinos with PyTrilinos. > > > No, I need that for a

Re: [deal.II] Computation of shape function gradients at the reference cell

2017-01-17 Thread Praveen C
Hi You can get them from your fe space. E.g., if you have FE_Q fe then you can do fe.shape_value(...) fe.shape_grad(..) etc. See https://www.dealii.org/developer/doxygen/deal.II/classFiniteElement.html Best praveen On Tue, Jan 17, 2017 at 4:25 PM, Tulio Ligneul < tulio.lign...@petrosoftdesi

Re: [deal.II] Re: neighboring faces on the boundary

2017-02-06 Thread Praveen C
Also this page might be useful https://www.dealii.org/8.4.1/doxygen/deal.II/structGeometryInfo.html It shows how the faces within a cell are topologically related to one another. Best praveen -- The deal.II project is located at http://www.dealii.org/ For mailing list/forum options, see https

Re: [deal.II] Nonhomogeneous Dirichlet Boundary conditions using a Dirichlet lift

2017-02-08 Thread Praveen C
Hello Giulia The usual way of applying Dirichlet bc in deal.II essentially does a lifting approach. If u = g on boundary then the lifting is u_{g,h}(x) = sum_(i on boundary) g(x_i) \phi_i(x) Did you want to use a different lifting ? Best praveen On Wed, Feb 8, 2017 at 8:38 PM, Giulia Deolmi

Re: [deal.II] ParameterHandler: MultipleSelection of couples

2017-02-08 Thread Praveen C
Hi In a similar case I have used this function http://www.dealii.org/developer/doxygen/deal.II/namespaceUtilities.html#a8d799bb35ac16d206818c88e82afbfae You can use this twice to get the result you want, combined with http://www.dealii.org/developer/doxygen/deal.II/namespaceUtilities.html#af501

Re: [deal.II] looking for an deallii example using trilinos's amesos direct solver in a parallel way

2017-02-10 Thread Praveen C
Hello Lailai Here is an example from my code where I use MUMPS via Trilinos static TrilinosWrappers::SolverDirect::AdditionalData data (false, "Amesos_Mumps"); static SolverControl solver_control (1, 0); // solve for x { TrilinosWrappers::MPI::Vector tmp (locally_owne

Re: [deal.II] looking for an deallii example using trilinos's amesos direct solver in a parallel way

2017-02-13 Thread Praveen C
On Tue, Feb 14, 2017 at 4:59 AM, Lailai Zhu wrote: > hi, Proveen, > > After implementing and testing by following your solutions, I realized two > issues. > When you use the mumps solver, how does it scale? i mean with a couple of > processors, say 4. > In my case, I tried to solve a test Laplace

[deal.II] Saving solution on sphere in lat/long coordinates

2017-03-02 Thread Praveen C
Dear all I solve a PDE on sphere and use parallel::distributed::Triangulation<2,3> triangulation; I would like to save the solution in latitude/longitude coordinates for visualization, so that I can make a 2-d plot, rather than view it on the sphere https://twitter.com/cfdlab/status/7937994665

  1   2   3   >