SFEMaNS  version 5.3
Reference documentation for SFEMaNS
condlim.f90
Go to the documentation of this file.
2  USE def_type_mesh
3  USE input_data
4  USE my_util
5  USE user_data
6  PUBLIC :: init_velocity_pressure
7  PUBLIC :: init_temperature
8  PUBLIC :: init_level_set
9  PUBLIC :: source_in_ns_momentum
10  PUBLIC :: source_in_temperature
11  PUBLIC :: source_in_level_set
12  PUBLIC :: vv_exact
14  PUBLIC :: pp_exact
15  PUBLIC :: temperature_exact
16  PUBLIC :: level_set_exact
17  PUBLIC :: penal_in_real_space
18  PUBLIC :: extension_velocity
19  PUBLIC :: vexact
20  PUBLIC :: h_b_quasi_static
21  PUBLIC :: hexact
22  PUBLIC :: phiexact
23  PUBLIC :: jexact_gauss
24  PUBLIC :: eexact_gauss
25  PUBLIC :: init_maxwell
26  PUBLIC :: mu_bar_in_fourier_space
28  PUBLIC :: mu_in_real_space
30  PUBLIC :: chi_coeff_law
31  PUBLIC :: t_dchi_dt_coeff_law
32  PUBLIC :: nu_tilde_law
33  PRIVATE
34 
35 CONTAINS
36  !===============================================================================
37  ! Boundary conditions for Navier-Stokes
38  !===============================================================================
39 
40  !===Initialize velocity, pressure
41  SUBROUTINE init_velocity_pressure(mesh_f, mesh_c, time, dt, list_mode, &
42  un_m1, un, pn_m1, pn, phin_m1, phin)
43  IMPLICIT NONE
44  TYPE(mesh_type) :: mesh_f, mesh_c
45  REAL(KIND=8), INTENT(OUT):: time
46  REAL(KIND=8), INTENT(IN) :: dt
47  INTEGER, DIMENSION(:), INTENT(IN) :: list_mode
48  REAL(KIND=8), DIMENSION(:,:,:), INTENT(OUT):: un_m1, un
49  REAL(KIND=8), DIMENSION(:,:,:), INTENT(OUT):: pn_m1, pn, phin_m1, phin
50  INTEGER :: mode, i, j
51  REAL(KIND=8), DIMENSION(mesh_c%np) :: pn_m2
52 
53  time = 0.d0
54  DO i= 1, SIZE(list_mode)
55  mode = list_mode(i)
56  DO j = 1, 6
57  !===velocity
58  un_m1(:,j,i) = vv_exact(j,mesh_f%rr,mode,time-dt)
59  un(:,j,i) = vv_exact(j,mesh_f%rr,mode,time)
60  END DO
61  DO j = 1, 2
62  !===pressure
63  pn_m2(:) = pp_exact(j,mesh_c%rr,mode,time-2*dt)
64  pn_m1(:,j,i) = pp_exact(j,mesh_c%rr,mode,time-dt)
65  pn(:,j,i) = pp_exact(j,mesh_c%rr,mode,time)
66  phin_m1(:,j,i) = pn_m1(:,j,i) - pn_m2(:)
67  phin(:,j,i) = pn(:,j,i) - pn_m1(:,j,i)
68  ENDDO
69  ENDDO
70  END SUBROUTINE init_velocity_pressure
71 
72  !===Initialize temperature
73  SUBROUTINE init_temperature(mesh, time, dt, list_mode, tempn_m1, tempn)
74  IMPLICIT NONE
75  TYPE(mesh_type) :: mesh
76  REAL(KIND=8), INTENT(OUT):: time
77  REAL(KIND=8), INTENT(IN) :: dt
78  INTEGER, DIMENSION(:), INTENT(IN) :: list_mode
79  REAL(KIND=8), DIMENSION(:,:,:), INTENT(OUT):: tempn_m1, tempn
80  INTEGER :: mode, i, j
81 
82  time = 0.d0
83  DO i= 1, SIZE(list_mode)
84  mode = list_mode(i)
85  DO j = 1, 2
86  tempn_m1(:,j,i) = temperature_exact(j, mesh%rr, mode, time-dt)
87  tempn(:,j,i) = temperature_exact(j, mesh%rr, mode, time)
88  ENDDO
89  ENDDO
90  END SUBROUTINE init_temperature
91 
92  !===Initialize level_set
93  SUBROUTINE init_level_set(pp_mesh, time, &
94  dt, list_mode, level_set_m1, level_set)
95  IMPLICIT NONE
96  TYPE(mesh_type) :: pp_mesh
97  REAL(KIND=8), INTENT(OUT):: time
98  REAL(KIND=8), INTENT(IN) :: dt
99  INTEGER, DIMENSION(:), INTENT(IN) :: list_mode
100  REAL(KIND=8), DIMENSION(:,:,:,:), INTENT(OUT):: level_set, level_set_m1
101  INTEGER :: mode, i, j, n
102 
103  time = 0.d0
104  DO i= 1, SIZE(list_mode)
105  mode = list_mode(i)
106  DO j = 1, 2
107  !===level_set
108  DO n = 1, inputs%nb_fluid -1
109  level_set_m1(n,:,j,i) = level_set_exact(n,j,pp_mesh%rr,mode,time-dt)
110  level_set(n,:,j,i) = level_set_exact(n,j,pp_mesh%rr,mode,time)
111  END DO
112  END DO
113  END DO
114  END SUBROUTINE init_level_set
115 
116  !===Source in momemtum equation. Always called.
117  FUNCTION source_in_ns_momentum(TYPE, rr, mode, i, time, Re, ty, opt_density, opt_tempn) RESULT(vv)
118  IMPLICIT NONE
119  INTEGER , INTENT(IN) :: TYPE
120  REAL(KIND=8), DIMENSION(:,:), INTENT(IN) :: rr
121  INTEGER , INTENT(IN) :: mode, i
122  REAL(KIND=8), INTENT(IN) :: time
123  REAL(KIND=8), INTENT(IN) :: Re
124  CHARACTER(LEN=2), INTENT(IN) :: ty
125  REAL(KIND=8), DIMENSION(:,:,:), OPTIONAL, INTENT(IN) :: opt_density
126  REAL(KIND=8), DIMENSION(:,:,:), OPTIONAL, INTENT(IN) :: opt_tempn
127  REAL(KIND=8), DIMENSION(SIZE(rr,2)) :: vv
128 
129  vv = 0.d0
130  RETURN
131  END FUNCTION source_in_ns_momentum
132 
133  !===Extra source in temperature equation. Always called.
134  FUNCTION source_in_temperature(TYPE, rr, m, t)RESULT(vv)
135  IMPLICIT NONE
136  INTEGER , INTENT(IN) :: TYPE
137  REAL(KIND=8), DIMENSION(:,:), INTENT(IN) :: rr
138  INTEGER , INTENT(IN) :: m
139  REAL(KIND=8), INTENT(IN) :: t
140  REAL(KIND=8), DIMENSION(SIZE(rr,2)) :: vv
141 
142  vv = 0.d0
143  RETURN
144  END FUNCTION source_in_temperature
145 
146  !===Extra source in level set equation. Always called.
147  FUNCTION source_in_level_set(interface_nb,TYPE, rr, m, t)RESULT(vv)
148  IMPLICIT NONE
149  INTEGER , INTENT(IN) :: TYPE
150  REAL(KIND=8), DIMENSION(:,:), INTENT(IN) :: rr
151  INTEGER , INTENT(IN) :: m, interface_nb
152  REAL(KIND=8), INTENT(IN) :: t
153  REAL(KIND=8), DIMENSION(SIZE(rr,2)) :: vv
154 
155  vv=0.d0
156  RETURN
157  END FUNCTION source_in_level_set
158 
159  !===Velocity for boundary conditions in Navier-Stokes.
160  !===Can be used also to initialize velocity in: init_velocity_pressure_temperature
161  FUNCTION vv_exact(TYPE,rr,m,t) RESULT(vv)
162  IMPLICIT NONE
163  INTEGER , INTENT(IN) :: TYPE
164  REAL(KIND=8), DIMENSION(:,:), INTENT(IN) :: rr
165  INTEGER, INTENT(IN) :: m
166  REAL(KIND=8), INTENT(IN) :: t
167  REAL(KIND=8), DIMENSION(SIZE(rr,2)) :: vv
168 
169  vv(:) = 0.d0
170  RETURN
171  END FUNCTION vv_exact
172 
173  !===Solid velocity imposed when using penalty technique
174  !===Defined in Fourier space on mode 0 only.
175  FUNCTION imposed_velocity_by_penalty(rr,t) RESULT(vv)
176  IMPLICIT NONE
177  REAL(KIND=8), DIMENSION(:,:), INTENT(IN) :: rr
178  REAL(KIND=8), INTENT(IN) :: t
179  REAL(KIND=8), DIMENSION(SIZE(rr,2),6) :: vv
180 
181  vv=0.d0
182  RETURN
183  END FUNCTION imposed_velocity_by_penalty
184 
185  !===Pressure for boundary conditions in Navier-Stokes.
186  !===Can be used also to initialize pressure in the subroutine init_velocity_pressure
187  !===Use this routine for outflow BCs only.
188  !===CAUTION: Do not enfore BCs on pressure where normal component
189  ! of velocity is prescribed.
190  FUNCTION pp_exact(TYPE,rr,m,t) RESULT (vv)
191  IMPLICIT NONE
192  INTEGER , INTENT(IN) :: TYPE
193  REAL(KIND=8), DIMENSION(:,:), INTENT(IN) :: rr
194  INTEGER , INTENT(IN) :: m
195  REAL(KIND=8), INTENT(IN) :: t
196  REAL(KIND=8), DIMENSION(SIZE(rr,2)) :: vv
197 
198  vv=0.d0
199  RETURN
200  END FUNCTION pp_exact
201 
202  !===Temperature for boundary conditions in temperature equation.
203  FUNCTION temperature_exact(TYPE,rr,m,t) RESULT (vv)
204  IMPLICIT NONE
205  INTEGER , INTENT(IN) :: TYPE
206  REAL(KIND=8), DIMENSION(:,:), INTENT(IN) :: rr
207  INTEGER , INTENT(IN) :: m
208  REAL(KIND=8), INTENT(IN) :: t
209  REAL(KIND=8), DIMENSION(SIZE(rr,2)) :: vv
210 
211  vv = 0.d0
212  RETURN
213  END FUNCTION temperature_exact
214 
215  !===Can be used to initialize level set in the subroutine init_level_set
216  FUNCTION level_set_exact(interface_nb,TYPE,rr,m,t) RESULT (vv)
217  IMPLICIT NONE
218  INTEGER , INTENT(IN) :: TYPE
219  REAL(KIND=8), DIMENSION(:,:), INTENT(IN) :: rr
220  INTEGER , INTENT(IN) :: m, interface_nb
221  REAL(KIND=8), INTENT(IN) :: t
222  REAL(KIND=8), DIMENSION(SIZE(rr,2)) :: vv
223 
224  vv = 0.d0
225  RETURN
226  END FUNCTION level_set_exact
227 
228  !===Penalty coefficient (if needed)
229  !===This coefficient is equal to zero in subdomain
230  !===where penalty is applied
231  FUNCTION penal_in_real_space(mesh,rr_gauss,angles,nb_angles,nb,ne,time) RESULT(vv)
232  IMPLICIT NONE
233  TYPE(mesh_type) :: mesh
234  REAL(KIND=8), DIMENSION(:,:), INTENT(IN) :: rr_gauss
235  REAL(KIND=8), DIMENSION(:), INTENT(IN) :: angles
236  INTEGER, INTENT(IN) :: nb_angles
237  INTEGER, INTENT(IN) :: nb, ne
238  REAL(KIND=8), INTENT(IN) :: time
239  REAL(KIND=8), DIMENSION(nb_angles,ne-nb+1) :: vv
240 
241  vv = 1.d0
242  RETURN
243  END FUNCTION penal_in_real_space
244 
245  !===Extension of the velocity field in the solid.
246  !===Used when temperature or Maxwell equations are solved.
247  !===It extends the velocity field on the Navier-Stokes domain to a
248  !===velocity field on the temperature and the Maxwell domain.
249  !===It is also used if problem type=mxw and restart velocity
250  !===is set to true in data (type problem denoted mxx in the code).
251  FUNCTION extension_velocity(TYPE, H_mesh, mode, t, n_start) RESULT(vv)
252  IMPLICIT NONE
253  TYPE(mesh_type), INTENT(IN) :: H_mesh
254  INTEGER , INTENT(IN) :: TYPE, n_start
255  INTEGER, INTENT(IN) :: mode
256  REAL(KIND=8), INTENT(IN) :: t
257  REAL(KIND=8), DIMENSION(H_Mesh%np) :: vv
258 
259  vv = 0.d0
260  RETURN
261  END FUNCTION extension_velocity
262 
263  !===============================================================================
264  ! Boundary conditions for Maxwell
265  !===============================================================================
266  !===Velocity used in the induction equation.
267  !===Used only if problem type is mxw and restart velocity is false
268  FUNCTION vexact(m, H_mesh) RESULT(vv) !Set uniquement a l'induction
269  IMPLICIT NONE
270  TYPE(mesh_type), INTENT(IN) :: H_mesh
271  INTEGER, INTENT(IN) :: m
272  REAL(KIND=8), DIMENSION(H_mesh%np,6) :: vv
273 
274  vv = 0.d0
275  RETURN
276  END FUNCTION vexact
277 
278  FUNCTION h_b_quasi_static(char_h_b, rr, m) RESULT(vv)
279  IMPLICIT NONE
280  CHARACTER(LEN=1), INTENT(IN) :: char_h_b
281  REAL(KIND=8), DIMENSION(:,:), INTENT(IN) :: rr
282  INTEGER, INTENT(IN) :: m
283  REAL(KIND=8), DIMENSION(SIZE(rr,2),6) :: vv
284 
285  IF (inputs%if_quasi_static_approx) THEN
286  vv = 0.d0
287  ELSE
288  CALL error_petsc('H_B_quasi_static should not be called')
289  END IF
290  RETURN
291  END FUNCTION h_b_quasi_static
292 
293  !===Magnetic field for boundary conditions in the Maxwell equations.
294  FUNCTION hexact(H_mesh, TYPE, rr, m, mu_H_field, t) RESULT(vv)
295  IMPLICIT NONE
296  TYPE(mesh_type), INTENT(IN) :: H_mesh
297  INTEGER , INTENT(IN) :: TYPE
298  REAL(KIND=8), DIMENSION(:,:), INTENT(IN) :: rr
299  INTEGER , INTENT(IN) :: m
300  REAL(KIND=8), INTENT(IN) :: t
301  REAL(KIND=8), DIMENSION(:), INTENT(IN) :: mu_H_field
302  REAL(KIND=8), DIMENSION(SIZE(rr,2)) :: vv
303 
304  vv = 0.d0
305  RETURN
306  END FUNCTION hexact
307 
308  !===Scalar potential for boundary conditions in the Maxwell equations.
309  FUNCTION phiexact(TYPE, rr, m, mu_phi,t) RESULT(vv)
310  IMPLICIT NONE
311  INTEGER , INTENT(IN) :: TYPE
312  REAL(KIND=8), DIMENSION(:,:), INTENT(IN) :: rr
313  INTEGER , INTENT(IN) :: m
314  REAL(KIND=8), INTENT(IN) :: mu_phi, t
315  REAL(KIND=8), DIMENSION(SIZE(rr,2)) :: vv
316 
317  vv = 0.d0
318  RETURN
319  END FUNCTION phiexact
320 
321  !===Current in Ohm's law. Curl(H) = sigma(E + uxB) + current
322  FUNCTION jexact_gauss(TYPE, rr, m, mu_phi, sigma, mu_H, t, mesh_id, opt_B_ext) RESULT(vv)
323  IMPLICIT NONE
324  INTEGER , INTENT(IN) :: TYPE
325  REAL(KIND=8), DIMENSION(:), INTENT(IN) :: rr
326  INTEGER , INTENT(IN) :: m
327  REAL(KIND=8), INTENT(IN) :: mu_phi, sigma, mu_H, t
328  INTEGER , INTENT(IN) :: mesh_id
329  REAL(KIND=8), DIMENSION(6), OPTIONAL,INTENT(IN) :: opt_B_ext
330  REAL(KIND=8) :: vv
331 
332  vv = 0.d0
333  RETURN
334  END FUNCTION jexact_gauss
335 
336  !===Electric field for Neumann BC (cf. doc)
337  FUNCTION eexact_gauss(TYPE, rr, m, mu_phi, sigma, mu_H, t) RESULT(vv)
338  IMPLICIT NONE
339  INTEGER, INTENT(IN) :: TYPE
340  REAL(KIND=8), DIMENSION(:), INTENT(IN) :: rr
341  INTEGER, INTENT(IN) :: m
342  REAL(KIND=8), INTENT(IN) :: mu_phi, sigma, mu_H, t
343  REAL(KIND=8) :: vv
344 
345  vv = 0.d0
346  RETURN
347  END FUNCTION eexact_gauss
348 
349  !===Initialization of magnetic field and scalar potential (if present)
350  SUBROUTINE init_maxwell(H_mesh, phi_mesh, time, dt, mu_H_field, mu_phi, &
351  list_mode, hn1, hn, phin1, phin)
352  IMPLICIT NONE
353  TYPE(mesh_type) :: H_mesh, phi_mesh
354  REAL(KIND=8), INTENT(OUT):: time
355  REAL(KIND=8), INTENT(IN) :: dt
356  REAL(KIND=8), DIMENSION(:), INTENT(IN) :: mu_H_field
357  REAL(KIND=8), INTENT(IN) :: mu_phi
358  INTEGER, DIMENSION(:), INTENT(IN) :: list_mode
359  REAL(KIND=8), DIMENSION(:,:,:), INTENT(OUT):: Hn, Hn1
360  REAL(KIND=8), DIMENSION(:,:,:), INTENT(OUT):: phin, phin1
361  INTEGER :: i, k
362 
363  time = -dt
364  DO k=1,6
365  DO i=1, SIZE(list_mode)
366  hn1(:,k,i) = hexact(h_mesh,k, h_mesh%rr, list_mode(i), mu_h_field, time)
367  IF (inputs%nb_dom_phi>0) THEN
368  IF (k<3) THEN
369  phin1(:,k,i) = phiexact(k, phi_mesh%rr, list_mode(i) , mu_phi, time)
370  ENDIF
371  END IF
372  ENDDO
373  ENDDO
374 
375  time = time + dt
376  DO k=1,6
377  DO i=1, SIZE(list_mode)
378  hn(:,k,i) = hexact(h_mesh,k, h_mesh%rr, list_mode(i), mu_h_field, time)
379  IF (inputs%nb_dom_phi>0) THEN
380  IF (k<3) THEN
381  phin(:,k,i) = phiexact(k, phi_mesh%rr, list_mode(i), mu_phi, time)
382  ENDIF
383  END IF
384  ENDDO
385  ENDDO
386  RETURN
387  END SUBROUTINE init_maxwell
388 
389  !===Analytical permeability (if needed)
390  !===This function is not needed unless the flag
391  !=== ===Use FEM Interpolation for magnetic permeability (true/false)
392  !===is activated and set to .FALSE. in the data data file. Default is .TRUE.
393  FUNCTION mu_bar_in_fourier_space(H_mesh,nb,ne,pts,pts_ids) RESULT(vv)
394  IMPLICIT NONE
395  TYPE(mesh_type), INTENT(IN) :: H_mesh
396  REAL(KIND=8), DIMENSION(ne-nb+1) :: vv
397  INTEGER, INTENT(IN) :: nb, ne
398  REAL(KIND=8),DIMENSION(2,ne-nb+1),OPTIONAL :: pts
399  INTEGER, DIMENSION(ne-nb+1), OPTIONAL :: pts_ids
400 
401  vv = 1.d0
402  RETURN
403  END FUNCTION mu_bar_in_fourier_space
404 
405  !===Analytical mu_in_fourier_space (if needed)
406  !===This function is not needed unless the flag
407  !=== ===Use FEM Interpolation for magnetic permeability (true/false)
408  !===is activated and set to .FALSE. in the data data file. Default is .TRUE.
409  FUNCTION grad_mu_bar_in_fourier_space(pt,pt_id) RESULT(vv)
410  IMPLICIT NONE
411  REAL(KIND=8),DIMENSION(2), INTENT(in):: pt
412  INTEGER,DIMENSION(1), INTENT(in) :: pt_id
413  REAL(KIND=8),DIMENSION(2) :: vv
414 
415  vv = 0.d0
416  RETURN
417  END FUNCTION grad_mu_bar_in_fourier_space
418 
419  !===Analytical permeability, mu in real space (if needed)
420  FUNCTION mu_in_real_space(H_mesh,angles,nb_angles,nb,ne,time) RESULT(vv)
421  IMPLICIT NONE
422  TYPE(mesh_type), INTENT(IN) :: H_mesh
423  REAL(KIND=8), DIMENSION(:), INTENT(IN) :: angles
424  INTEGER, INTENT(IN) :: nb_angles
425  INTEGER, INTENT(IN) :: nb, ne
426  REAL(KIND=8), INTENT(IN) :: time
427  REAL(KIND=8), DIMENSION(nb_angles,ne-nb+1) :: vv
428 
429  vv = 1.d0
430  RETURN
431  END FUNCTION mu_in_real_space
432 
433  !=== Only used for multiphase flow with variable electrical conductivity
434  !===This function is not needed unless the following line is in the data
435  !=== ===Conductivity of fluid 0, fluid 1, ...
436  !=== The above line should be followed by the value of the conductivity in the different fluids.
437  !=== The result vv has to smaller than the effective conductivity on every nodes of the mesh.
438  FUNCTION sigma_bar_in_fourier_space(H_mesh) RESULT(vv)
440  IMPLICIT NONE
441  TYPE(mesh_type), INTENT(IN) :: H_mesh
442  REAL(KIND=8), DIMENSION(SIZE(H_mesh%rr,2)) :: vv
443 
444  vv=0.9d0*minval(inputs%sigma_fluid)
445  RETURN
446  END FUNCTION sigma_bar_in_fourier_space
447 
448  !===Coefficient contaning the magnetic susceptibility for magnetic force in ferrofluids:
449  !===F = chi_coeff(T) * grad(H**2/2) (Kelvin form)
450  !===or F = -H**2/2 * grad(chi_coeff(T)) (Helmholtz form)
451  FUNCTION chi_coeff_law(temp) RESULT(vv)
452  IMPLICIT NONE
453  REAL(KIND=8) :: temp
454  REAL(KIND=8) :: vv
455 
456  vv = 0.d0*temp
457  RETURN
458  END FUNCTION chi_coeff_law
459 
460  !===Coefficient contaning the temperature dependant factor in the
461  !===pyromagnetic coefficient term of the temperature equation for ferrofluids:
462  !===T * dchi/dT(T) * D/Dt(H**2/2)
463  FUNCTION t_dchi_dt_coeff_law(temp) RESULT(vv)
464  IMPLICIT NONE
465  REAL(KIND=8) :: temp
466  REAL(KIND=8) :: vv
467 
468  vv = 0.d0*temp
469  RETURN
470  END FUNCTION t_dchi_dt_coeff_law
471 
472  !===Kinematic viscosity's law of temperature
473  FUNCTION nu_tilde_law(temp) RESULT(vv)
474  IMPLICIT NONE
475  REAL(KIND=8) :: temp
476  REAL(KIND=8) :: vv
477 
478  vv = 0.d0*temp
479  RETURN
480  END FUNCTION nu_tilde_law
481 
482 END MODULE boundary_generic
real(kind=8) function, public chi_coeff_law(temp)
Definition: condlim.f90:452
real(kind=8) function, dimension(size(rr, 2)), public source_in_ns_momentum(TYPE, rr, mode, i, time, Re, ty, opt_density, opt_tempn)
Definition: condlim.f90:118
real(kind=8) function, public eexact_gauss(TYPE, rr, m, mu_phi, sigma, mu_H, t)
Definition: condlim.f90:338
real(kind=8) function, dimension(h_mesh%np), public extension_velocity(TYPE, H_mesh, mode, t, n_start)
Definition: condlim.f90:252
subroutine, public init_velocity_pressure(mesh_f, mesh_c, time, dt, list_mode, un_m1, un, pn_m1, pn, phin_m1, phin)
Definition: condlim.f90:43
real(kind=8) function, dimension(size(rr, 2)), public pp_exact(TYPE, rr, m, t)
Definition: condlim.f90:191
real(kind=8) function, public t_dchi_dt_coeff_law(temp)
Definition: condlim.f90:464
subroutine error_petsc(string)
Definition: my_util.f90:16
type(my_data), public inputs
real(kind=8) function, dimension(h_mesh%np, 6), public vexact(m, H_mesh)
Definition: condlim.f90:269
real(kind=8) function, dimension(size(rr, 2)), public level_set_exact(interface_nb, TYPE, rr, m, t)
Definition: condlim.f90:217
real(kind=8) function, public jexact_gauss(TYPE, rr, m, mu_phi, sigma, mu_H, t, mesh_id, opt_B_ext)
Definition: condlim.f90:323
real(kind=8) function, dimension(size(rr, 2)), public phiexact(TYPE, rr, m, mu_phi, t)
Definition: condlim.f90:310
real(kind=8) function, dimension(size(rr, 2)), public vv_exact(TYPE, rr, m, t)
Definition: condlim.f90:162
real(kind=8) function, dimension(nb_angles, ne-nb+1), public penal_in_real_space(mesh, rr_gauss, angles, nb_angles, nb, ne, time)
Definition: condlim.f90:232
real(kind=8) function, dimension(2), public grad_mu_bar_in_fourier_space(pt, pt_id)
Definition: condlim.f90:410
subroutine, public init_temperature(mesh, time, dt, list_mode, tempn_m1, tempn)
Definition: condlim.f90:74
real(kind=8) function, dimension(size(rr, 2)), public temperature_exact(TYPE, rr, m, t)
Definition: condlim.f90:204
real(kind=8) function, dimension(size(rr, 2)), public source_in_level_set(interface_nb, TYPE, rr, m, t)
Definition: condlim.f90:148
real(kind=8) function, dimension(size(rr, 2), 6), public h_b_quasi_static(char_h_b, rr, m)
Definition: condlim.f90:279
subroutine, public init_maxwell(H_mesh, phi_mesh, time, dt, mu_H_field, mu_phi, list_mode, Hn1, Hn, phin1, phin)
Definition: condlim.f90:352
real(kind=8) function, public nu_tilde_law(temp)
Definition: condlim.f90:474
real(kind=8) function, dimension(nb_angles, ne-nb+1), public mu_in_real_space(H_mesh, angles, nb_angles, nb, ne, time)
Definition: condlim.f90:421
real(kind=8) function, dimension(size(h_mesh%rr, 2)), public sigma_bar_in_fourier_space(H_mesh)
Definition: condlim.f90:439
real(kind=8) function, dimension(size(rr, 2)), public source_in_temperature(TYPE, rr, m, t)
Definition: condlim.f90:135
subroutine, public init_level_set(pp_mesh, time, dt, list_mode, level_set_m1, level_set)
Definition: condlim.f90:95
real(kind=8) function, dimension(size(rr, 2), 6), public imposed_velocity_by_penalty(rr, t)
Definition: condlim.f90:176
real(kind=8) function, dimension(size(rr, 2)), public hexact(H_mesh, TYPE, rr, m, mu_H_field, t)
Definition: condlim.f90:295
real(kind=8) function, dimension(ne-nb+1), public mu_bar_in_fourier_space(H_mesh, nb, ne, pts, pts_ids)
Definition: condlim.f90:394