Re: [deal.II] Different basis functions and polynomial degrees for each space direction

2024-05-20 Thread giuseppe orlando
Dear Wolfgang, thanks for the kind response. As a starting point, I would need to focus on a scalar field, hence a finite element space for scalar values would be sufficient, but obviously the mid-long term goal is to employ vector-value finite element as well. I will try to have a look to the

[deal.II] Different basis functions and polynomial degrees for each space direction

2024-05-14 Thread giuseppe orlando
Hello everyone, I'm writing this post because I would need help to build a "particular" finite element space. Let us suppose to have a scalar field in 2D. I want to consider a family of basis functions along the horizontal direction (e.g. basis functions based on Legendre polynomials) and a

Re: [deal.II] Re: Issue on CUDA code

2023-08-22 Thread giuseppe orlando
periodic bcs in a matrix-free framework for CUDA. Thanks in advance Best regards, Giuseppe Il giorno martedì 18 luglio 2023 alle 17:31:17 UTC+2 giuseppe orlando ha scritto: > Dear Bruno, > thank you very much. I am having some troubles to install the new version > with CUDA and

R: [deal.II] Re: Compilation deal.II 9.5

2023-07-20 Thread Giuseppe Orlando
Yes, I’m inside a clean directory. The output of mpicxx is “/opt/cray/pe/craype/2.7.10/bin/CC”, which is the same that I used to install all the other versions. The cmake version is 3.17.0. Best Giuseppe Orlando Da: Bruno TurcksinInviato: giovedì 20 luglio 2023 17:47A: dealii

Re: [deal.II] Re: Compilation deal.II 9.5

2023-07-20 Thread giuseppe orlando
ags > it might be passed to MPI when it shouldn't. The rest looks good. > > Best, > > Bruno > > > Le mer. 19 juil. 2023 à 13:29, giuseppe orlando a > écrit : > >> Dear Bruno, >> thanks for the suggestion. I tried to follow it, but I still the get same >&

[deal.II] Re: Compilation deal.II 9.5

2023-07-19 Thread giuseppe orlando
Dear Bruno, thanks for the suggestion. I tried to follow it, but I still the get same error during the creation of the Makefile. Just to sum up I typed "export OMPI_CXX=/project/sm77/bin/kokkos/bin/nvcc_wrapper" "cmake -DCMAKE_INSTALL_PREFIX=/project/sm77/bin/dealII/9.5.1/

[deal.II] Compilation deal.II 9.5

2023-07-19 Thread giuseppe orlando
Hello everyone, I'm writing this post because I'm having some issues to compile the latest release. I would need a version which supports CUDA and MPI being CUDA-aware. Hence, I installed Kokkos using the flags -DKokkos_ENABLE_CUDA=ON and -DKokkos_ENABLE_CUDA_LAMBDA=ON. Then, I tried to build

Re: [deal.II] Re: Issue on CUDA code

2023-07-18 Thread giuseppe orlando
ew code is not 100% backward compatible but the changes are pretty > small. I advise you to switch to the latest version of deal.II, debug the > code on the CPU, and then run on the GPU. > > Best, > > Bruno > > Le lun. 17 juil. 2023 à 14:12, giuseppe orlando a > éc

Re: [deal.II] Re: Issue on CUDA code

2023-07-17 Thread giuseppe orlando
gt; Bruno > > Le lun. 17 juil. 2023 à 11:06, giuseppe orlando a > écrit : > >> Here, you can find the two codes. 'SBR_GPU' is the one that arrives up to >> the end, whereas 'SBR_GPU_WRONG' is the one that stops with the error >> described above once I call 'output_result

[deal.II] Re: Issue on CUDA code

2023-07-17 Thread giuseppe orlando
Here, you can find the two codes. 'SBR_GPU' is the one that arrives up to the end, whereas 'SBR_GPU_WRONG' is the one that stops with the error described above once I call 'output_results'. If the code is too long and can be helpful, I could try to reduce it avoiding ParameterHandler and other

[deal.II] Issue on CUDA code

2023-07-17 Thread giuseppe orlando
Hello everyone, I'm writing this post to ask some help for a CUDA code. I have implemented a matrix-based CUDA coda for the so-called solid body rotation, namely a time dependent advection problem. In my first implementation, I encapulased the computation of the matrix and of the right-hand

[deal.II] MatrixFree spacedim different than dim

2023-05-20 Thread giuseppe orlando
Hello everyone, I am writing this post to ask a curiosity about the MatrixFree infrastructure. Is it possible to employ it for solving PDEs on surface (like step-38 tutorial). Indeed, looking at the documentation of the reinit function, it seems that only a 'DofHanlder' instance is accepted,

R: [deal.II] Re: CUDA facilities

2023-05-08 Thread Giuseppe Orlando
Dear Bruno,thanks for the kind response. I will certainly have a look to the files that you suggested me about the CUDAWrappers::SparseMatrix (and also the other tests included therein). Just as curiosity (if I am not inappropriate and you can answer me): are these new GPU facilities with Kokkos

[deal.II] CUDA facilities

2023-05-08 Thread giuseppe orlando
Hello everyone, I am writing this post to ask a couple of questions about the CUDA facilities in deal.II, after a look on step-64 tutorial. 1. Searching for the documentation, I noticed that routines such as CUDAWrappers::FEFaceEvalution or CUDAWrappers::MatrixFree::loop are not defined. Am I

[deal.II] Minisymposium at Enumath 2023

2022-11-14 Thread giuseppe orlando
would be interested in organizing a mini-symposium on “Computational Fluid Dynamics Applications based on *deal.II*”, possibly in collaboration with some of the developers. Please, let me know if this can be of interest for you. Best, Giuseppe Orlando -- The deal.II project is located

[deal.II] Integral over different lines

2022-03-11 Thread giuseppe orlando
Good morning everyone, I would have a question about the computation of integrals. Suppose I have a rectangular domain, is it there any way to compute the integral of a certain function over different heights (not only on the bottom or top boundary)? Thanks in advance, Giuseppe -- The

Re: [deal.II] FunctionManifold class

2022-02-01 Thread giuseppe orlando
to use FunctionManifold with an analytical > function. Most of them use std::strings but > tests/fe/fe_values_function_manifold.cc and > tests/mappings/mapping_q_manifold_02.cc actually use Function objects. > > Best, > Daniel > > Am Mo., 31. Jan. 2022 um 02:56 Uhr schrieb

[deal.II] FunctionManifold class

2022-01-30 Thread giuseppe orlando
Good morning everyone, I would have a question about the creation of a triangulation. Is it possible to use the 'FunctionManifold' class to create a boundary described by an analytical function? If so, how can I attach this manifold and "substitute" for instance the default straight boundary of

[deal.II] DG Euler eqautions (step-33 and step-67)

2020-12-08 Thread giuseppe orlando
Dear Deal.II community, I'm currently working on DG formulation for Euler equations with implicit time-stepping, trying to combine in some sense the two approaches of ste-33 and step-67. I'm wondering if there is a way to employ automatic differentiation in the matrix-free approach; I think