[cig-commits] [commit] Hiro_latest: Change order of defining reference temperature and boundary conditions (5447e7a)

cig_noreply at geodynamics.org cig_noreply at geodynamics.org
Mon Nov 18 16:21:40 PST 2013


Repository : ssh://geoshell/calypso

On branch  : Hiro_latest
Link       : https://github.com/geodynamics/calypso/compare/93e9f8f974c7a247c8f02e54ec18de063f86c8fb...3c548304673360ddedd7d68c8095b3fb74a2b9ce

>---------------------------------------------------------------

commit 5447e7a65599c2fa15b066e776ed4ea167aa0300
Author: Hiroaki Matsui <h_kemono at mac.com>
Date:   Tue Nov 12 00:15:02 2013 -0500

    Change order of defining reference temperature and boundary conditions


>---------------------------------------------------------------

5447e7a65599c2fa15b066e776ed4ea167aa0300
 .../MHD_src/sph_MHD/set_bc_flag_sph_velo.f90       |   2 +-
 .../MHD_src/sph_MHD/set_bc_sph_mhd.f90             | 156 +++++++++++++++++----
 .../MHD_src/sph_MHD/set_bc_sph_scalars.f90         |  84 +----------
 .../MHD_src/sph_MHD/set_reference_sph_mhd.f90      |  30 +++-
 src/Makefile                                       |   4 +-
 src/programs/SPH_MHD/SPH_analyzer_MHD.f90          |  26 ++--
 .../INITIAL_FIELD/SPH_analyzer_const_initial.f90   |  35 -----
 .../SNAPSHOT_MHD/SPH_analyzer_d_bench.f90          |  20 +--
 .../SNAPSHOT_MHD/SPH_analyzer_snap.f90             |  20 +--
 9 files changed, 180 insertions(+), 197 deletions(-)

diff --git a/src/Fortran_libraries/MHD_src/sph_MHD/set_bc_flag_sph_velo.f90 b/src/Fortran_libraries/MHD_src/sph_MHD/set_bc_flag_sph_velo.f90
index aaf277f..fa34036 100644
--- a/src/Fortran_libraries/MHD_src/sph_MHD/set_bc_flag_sph_velo.f90
+++ b/src/Fortran_libraries/MHD_src/sph_MHD/set_bc_flag_sph_velo.f90
@@ -7,7 +7,7 @@
 !>@brief Set boundary conditions flags for velocity
 !!
 !!@verbatim
-!!      subroutine s_set_bc_sph_mhd
+!!      subroutine set_sph_bc_velo_sph
 !!@endverbatim
 !
       module set_bc_flag_sph_velo
diff --git a/src/Fortran_libraries/MHD_src/sph_MHD/set_bc_sph_mhd.f90 b/src/Fortran_libraries/MHD_src/sph_MHD/set_bc_sph_mhd.f90
index 2fbb2dc..9a993cf 100644
--- a/src/Fortran_libraries/MHD_src/sph_MHD/set_bc_sph_mhd.f90
+++ b/src/Fortran_libraries/MHD_src/sph_MHD/set_bc_sph_mhd.f90
@@ -35,6 +35,8 @@
 !
       use set_bc_flag_sph_velo
       use set_bc_sph_scalars
+      use set_reference_sph_mhd
+      use cal_sph_bc_fdm_matrix
 !
 !
       if (iflag_t_evo_4_velo .gt.     id_no_evolution) then
@@ -54,40 +56,48 @@
       end if
 !
 !
+      call set_radial_range_by_BC(iflag_icb_velocity,                   &
+     &     kr_in_U, kr_out_U)
+      call set_radial_range_by_BC(iflag_icb_temp, kr_in_T, kr_out_T)
+      call set_radial_range_by_BC(iflag_icb_composition,                &
+     &    kr_in_C, kr_out_C)
+      call set_radial_range_by_BC(iflag_icb_magne, kr_in_B, kr_out_B)
 !
-      if      (iflag_icb_velocity .eq. iflag_sph_fill_center            &
-     &    .or. iflag_icb_velocity .eq. iflag_sph_fix_center) then
-        kr_in_U = nlayer_2_center
-      else
-        kr_in_U = nlayer_ICB
-      end if
-      kr_out_U = nlayer_CMB
+!      Set reference temperature and adjust boundary conditions
 !
-      if      (iflag_icb_temp .eq. iflag_sph_fill_center                &
-     &    .or. iflag_icb_temp .eq. iflag_sph_fix_center) then
-        kr_in_T = nlayer_2_center
-      else
-        kr_in_T = nlayer_ICB
-      end if
-      kr_out_T = nlayer_CMB
+      call allocate_reft_rj_data
+      call set_ref_temp_sph_mhd
+      call adjust_sph_temp_bc_by_reftemp
 !
-      if      (iflag_icb_composition .eq. iflag_sph_fill_center         &
-     &    .or. iflag_icb_composition .eq. iflag_sph_fix_center) then
-        kr_in_C = nlayer_2_center
-      else
-        kr_in_C = nlayer_ICB
-      end if
-      kr_out_C = nlayer_CMB
+!      Det FDM matrices for boundaries
+!
+      if (iflag_debug.gt.0) write(*,*) 's_cal_sph_bc_fdm_matrices'
+      call s_cal_sph_bc_fdm_matrices
+!
+!      Check data
+!
+      if(i_debug .gt. 1) call check_sph_bc_temp_sph
+      if(i_debug .gt. 1) call check_sph_bc_composition_sph
+!
+      end subroutine s_set_bc_sph_mhd
+!
+! -----------------------------------------------------------------------
+!
+      subroutine set_radial_range_by_BC(iflag_icb_bc, kr_in, kr_out)
 !
-      if      (iflag_icb_magne .eq. iflag_sph_fill_center               &
-     &    .or. iflag_icb_magne .eq. iflag_sph_fix_center) then
-        kr_in_B = nlayer_2_center
+      integer(kind = kint), intent(in) :: iflag_icb_bc
+      integer(kind = kint), intent(inout) :: kr_in, kr_out
+!
+!
+      if      (iflag_icb_bc .eq. iflag_sph_fill_center                  &
+     &    .or. iflag_icb_bc .eq. iflag_sph_fix_center) then
+        kr_in = nlayer_2_center
       else
-        kr_in_B = nlayer_ICB
+        kr_in = nlayer_ICB
       end if
-      kr_out_B = nlayer_CMB
+      kr_out =  nlayer_CMB
 !
-      end subroutine s_set_bc_sph_mhd
+      end subroutine set_radial_range_by_BC
 !
 ! -----------------------------------------------------------------------
 !
@@ -154,4 +164,96 @@
 !
 ! -----------------------------------------------------------------------
 !
+      subroutine check_sph_bc_temp_sph
+!
+      use m_spheric_parameter
+      use m_bc_data_list
+      use m_surf_data_list
+!
+      integer(kind = kint) :: i
+!
+!
+      if(iflag_debug .gt. 0) then
+        write(*,*) 'h_flux_surf%num_bc',       h_flux_surf%num_bc
+        write(*,*) 'h_flux_surf%ibc_type',     h_flux_surf%ibc_type
+        write(*,*) 'h_flux_surf%bc_magnitude', h_flux_surf%bc_magnitude
+      end if
+!
+      if(i_debug .gt. 1) then
+        write(*,*) 'iflag_icb_temp', iflag_icb_temp
+        if(iflag_icb_temp .eq. iflag_fixed_field) then
+          do i = 1, nidx_rj(2)
+            write(*,*) 'temp_ICB', idx_gl_1d_rj_j(i,1:3),               &
+     &                  temp_ICB_bc(i)
+          end do
+        end if
+        if(iflag_icb_temp .eq. iflag_fixed_flux) then
+          do i = 1, nidx_rj(2)
+            write(*,*) 'heat_flux_ICB', idx_gl_1d_rj_j(i,1:3),          &
+     &                  h_flux_ICB_bc(i)
+          end do
+        end if
+!
+        write(*,*) 'iflag_cmb_temp', iflag_cmb_temp
+        if(iflag_cmb_temp .eq. iflag_fixed_field) then
+          do i = 1, nidx_rj(2)
+            write(*,*) 'temp_CMB', idx_gl_1d_rj_j(i,1:3),               &
+     &                  temp_CMB_bc(i)
+          end do
+        end if
+        if(iflag_cmb_temp .eq. iflag_fixed_flux) then
+          do i = 1, nidx_rj(2)
+            write(*,*) 'heat_flux_CMB', idx_gl_1d_rj_j(i,1:3),          &
+     &                  h_flux_CMB_bc(i)
+          end do
+        end if
+!
+      end if
+!
+      end subroutine check_sph_bc_temp_sph
+!
+! -----------------------------------------------------------------------
+!
+      subroutine check_sph_bc_composition_sph
+!
+      use m_spheric_parameter
+!
+      integer(kind = kint) :: i
+!
+!
+      if(i_debug .gt. 1) then
+        write(*,*) 'iflag_icb_composition', iflag_icb_composition
+        if(iflag_icb_composition .eq. iflag_fixed_field) then
+          do i = 1, nidx_rj(2)
+            write(*,*) 'comp_ICB', idx_gl_1d_rj_j(i,1:3),               &
+     &                  composition_ICB_bc(i)
+          end do
+        end if
+        if(iflag_icb_composition .eq. iflag_fixed_flux) then
+          do i = 1, nidx_rj(2)
+            write(*,*) 'comp_flux_ICB', idx_gl_1d_rj_j(i,1:3),          &
+     &                  c_flux_ICB_bc(i)
+          end do
+        end if
+!
+        write(*,*) 'iflag_cmb_composition', iflag_cmb_composition
+        if(iflag_cmb_composition .eq. iflag_fixed_field) then
+          do i = 1, nidx_rj(2)
+            write(*,*) 'comp_CMB', idx_gl_1d_rj_j(i,1:3),               &
+     &                  composition_CMB_bc(i)
+          end do
+        end if
+        if(iflag_cmb_composition .eq. iflag_fixed_flux) then
+          do i = 1, nidx_rj(2)
+            write(*,*) 'comp_flux_CMB', idx_gl_1d_rj_j(i,1:3),          &
+     &                  c_flux_CMB_bc(i)
+          end do
+        end if
+!
+      end if
+!
+      end subroutine check_sph_bc_composition_sph
+!
+! -----------------------------------------------------------------------
+!
       end module set_bc_sph_mhd
diff --git a/src/Fortran_libraries/MHD_src/sph_MHD/set_bc_sph_scalars.f90 b/src/Fortran_libraries/MHD_src/sph_MHD/set_bc_sph_scalars.f90
index 433eafe..b68bfd9 100644
--- a/src/Fortran_libraries/MHD_src/sph_MHD/set_bc_sph_scalars.f90
+++ b/src/Fortran_libraries/MHD_src/sph_MHD/set_bc_sph_scalars.f90
@@ -7,7 +7,9 @@
 !>@brief Set boundary conditions for scalar fields
 !!
 !!@verbatim
-!!      subroutine s_set_bc_sph_mhd
+!!      subroutine set_sph_bc_temp_sph
+!!      subroutine set_sph_bc_composition_sph
+!!      subroutine adjust_sph_temp_bc_by_reftemp
 !!@endverbatim
 !
       module set_bc_sph_scalars
@@ -45,12 +47,6 @@
 !
       call allocate_temp_bc_array( nidx_rj(2) )
 !
-      if(iflag_debug .gt. 0) then
-        write(*,*) 'h_flux_surf%num_bc',       h_flux_surf%num_bc
-        write(*,*) 'h_flux_surf%ibc_type',     h_flux_surf%ibc_type
-        write(*,*) 'h_flux_surf%bc_magnitude', h_flux_surf%bc_magnitude
-      end if
-!
       do i = 1, h_flux_surf%num_bc
         if ( h_flux_surf%ibc_type(i)  .eq. iflag_bc_fix_s) then
           call set_homogenious_grad_bc                                  &
@@ -122,49 +118,6 @@
 !
       h_flux_ICB_bc(1:nidx_rj(2)) = - h_flux_ICB_bc(1:nidx_rj(2))
 !
-      if(idx_rj_degree_zero .gt. 0                                      &
-     &      .and. iflag_4_ref_temp .eq. id_sphere_ref_temp) then
-        temp_ICB_bc(idx_rj_degree_zero)                                 &
-     &   = temp_ICB_bc(idx_rj_degree_zero) - reftemp_rj(nlayer_ICB,0)
-        temp_CMB_bc(idx_rj_degree_zero)                                 &
-     &   = temp_CMB_bc(idx_rj_degree_zero) - reftemp_rj(nlayer_CMB,0)
-        h_flux_ICB_bc(idx_rj_degree_zero)                               &
-     &   = h_flux_ICB_bc(idx_rj_degree_zero) - reftemp_rj(nlayer_ICB,1)
-        h_flux_CMB_bc(idx_rj_degree_zero)                               &
-     &   = h_flux_CMB_bc(idx_rj_degree_zero) - reftemp_rj(nlayer_CMB,1)
-      end if
-!
-      if(i_debug .gt. 1) then
-        write(*,*) 'iflag_icb_temp', iflag_icb_temp
-        if(iflag_icb_temp .eq. iflag_fixed_field) then
-          do i = 1, nidx_rj(2)
-            write(*,*) 'temp_ICB', idx_gl_1d_rj_j(i,1:3),               &
-     &                  temp_ICB_bc(i)
-          end do
-        end if
-        if(iflag_icb_temp .eq. iflag_fixed_flux) then
-          do i = 1, nidx_rj(2)
-            write(*,*) 'heat_flux_ICB', idx_gl_1d_rj_j(i,1:3),          &
-     &                  h_flux_ICB_bc(i)
-          end do
-        end if
-!
-        write(*,*) 'iflag_cmb_temp', iflag_cmb_temp
-        if(iflag_cmb_temp .eq. iflag_fixed_field) then
-          do i = 1, nidx_rj(2)
-            write(*,*) 'temp_CMB', idx_gl_1d_rj_j(i,1:3),               &
-     &                  temp_CMB_bc(i)
-          end do
-        end if
-        if(iflag_cmb_temp .eq. iflag_fixed_flux) then
-          do i = 1, nidx_rj(2)
-            write(*,*) 'heat_flux_CMB', idx_gl_1d_rj_j(i,1:3),          &
-     &                  h_flux_CMB_bc(i)
-          end do
-        end if
-!
-      end if
-!
       end subroutine set_sph_bc_temp_sph
 !
 ! -----------------------------------------------------------------------
@@ -257,37 +210,6 @@
 !
       c_flux_ICB_bc(1:nidx_rj(2)) = -c_flux_ICB_bc(1:nidx_rj(2))
 !
-      if(i_debug .gt. 1) then
-        write(*,*) 'iflag_icb_composition', iflag_icb_composition
-        if(iflag_icb_composition .eq. iflag_fixed_field) then
-          do i = 1, nidx_rj(2)
-            write(*,*) 'comp_ICB', idx_gl_1d_rj_j(i,1:3),               &
-     &                  composition_ICB_bc(i)
-          end do
-        end if
-        if(iflag_icb_composition .eq. iflag_fixed_flux) then
-          do i = 1, nidx_rj(2)
-            write(*,*) 'comp_flux_ICB', idx_gl_1d_rj_j(i,1:3),          &
-     &                  c_flux_ICB_bc(i)
-          end do
-        end if
-!
-        write(*,*) 'iflag_cmb_composition', iflag_cmb_composition
-        if(iflag_cmb_composition .eq. iflag_fixed_field) then
-          do i = 1, nidx_rj(2)
-            write(*,*) 'comp_CMB', idx_gl_1d_rj_j(i,1:3),               &
-     &                  composition_CMB_bc(i)
-          end do
-        end if
-        if(iflag_cmb_composition .eq. iflag_fixed_flux) then
-          do i = 1, nidx_rj(2)
-            write(*,*) 'comp_flux_CMB', idx_gl_1d_rj_j(i,1:3),          &
-     &                  c_flux_CMB_bc(i)
-          end do
-        end if
-!
-      end if
-!
       end subroutine set_sph_bc_composition_sph
 !
 ! -----------------------------------------------------------------------
diff --git a/src/Fortran_libraries/MHD_src/sph_MHD/set_reference_sph_mhd.f90 b/src/Fortran_libraries/MHD_src/sph_MHD/set_reference_sph_mhd.f90
index fc523c8..867ca54 100644
--- a/src/Fortran_libraries/MHD_src/sph_MHD/set_reference_sph_mhd.f90
+++ b/src/Fortran_libraries/MHD_src/sph_MHD/set_reference_sph_mhd.f90
@@ -9,7 +9,7 @@
 !!@verbatim
 !!      subroutine adjust_by_ave_pressure_on_CMB
 !!
-!!      subroutine s_set_ref_temp_sph_mhd
+!!      subroutine set_ref_temp_sph_mhd
 !!
 !!      subroutine sync_temp_by_per_temp_sph
 !!        d_rj(inod,ipol%i_temp):        T => \Theta = T - T0
@@ -24,6 +24,7 @@
 !!        d_rj(inod,ipol%i_grad_t):      d \Theta / dr   => dT / dr
 !!        d_rj(inod,ipol%i_grad_part_t): d \Theta / dr
 !!
+!!      subroutine adjust_sph_temp_bc_by_reftemp
 !!      subroutine delete_zero_degree_comp(is_fld)
 !!@endverbatim
 !!
@@ -70,7 +71,7 @@
 ! -----------------------------------------------------------------------
 ! -----------------------------------------------------------------------
 !
-      subroutine s_set_ref_temp_sph_mhd
+      subroutine set_ref_temp_sph_mhd
 !
       integer (kind = kint) :: k
 !
@@ -102,7 +103,7 @@
         depth_low_t =  r_CMB
       end if
 !
-      end subroutine s_set_ref_temp_sph_mhd
+      end subroutine set_ref_temp_sph_mhd
 !
 ! -----------------------------------------------------------------------
 !
@@ -167,6 +168,29 @@
       end subroutine trans_per_temp_to_temp_sph
 !
 ! -----------------------------------------------------------------------
+!
+      subroutine adjust_sph_temp_bc_by_reftemp
+!
+      use m_spheric_parameter
+      use m_sph_spectr_data
+      use m_control_params_sph_MHD
+!
+!
+      if(idx_rj_degree_zero .gt. 0                                      &
+     &      .and. iflag_4_ref_temp .eq. id_sphere_ref_temp) then
+        temp_ICB_bc(idx_rj_degree_zero)                                 &
+     &   = temp_ICB_bc(idx_rj_degree_zero) - reftemp_rj(nlayer_ICB,0)
+        temp_CMB_bc(idx_rj_degree_zero)                                 &
+     &   = temp_CMB_bc(idx_rj_degree_zero) - reftemp_rj(nlayer_CMB,0)
+        h_flux_ICB_bc(idx_rj_degree_zero)                               &
+     &   = h_flux_ICB_bc(idx_rj_degree_zero) - reftemp_rj(nlayer_ICB,1)
+        h_flux_CMB_bc(idx_rj_degree_zero)                               &
+     &   = h_flux_CMB_bc(idx_rj_degree_zero) - reftemp_rj(nlayer_CMB,1)
+      end if
+!
+      end subroutine adjust_sph_temp_bc_by_reftemp
+!
+! -----------------------------------------------------------------------
 ! -----------------------------------------------------------------------
 !
       subroutine delete_zero_degree_comp(is_fld)
diff --git a/src/Makefile b/src/Makefile
index 53709ef..1137c7a 100644
--- a/src/Makefile
+++ b/src/Makefile
@@ -200,7 +200,7 @@ makemake:
 		GMAKE='$(GMAKE)' \
 		FFTW3_LIBS='$(FFTW3_LIBS)'   \
 		MAKEDIR='$(MAKEDIR)' \
-		MAKENAME='$(MAKENAME)' \
+		MAKENAME='$(MAKENAME)'\
 		mod_list; \
 		 ) \
 	done
@@ -213,7 +213,7 @@ makemake:
 		$(GMAKE) \
 		GMAKE='$(GMAKE)' \
 		MAKENAME='$(MAKENAME)' \
-		target_task \
+		target_task; \
 		) \
 	done
 	@echo 'create library construct list...'
diff --git a/src/programs/SPH_MHD/SPH_analyzer_MHD.f90 b/src/programs/SPH_MHD/SPH_analyzer_MHD.f90
index 6886edc..42a274a 100644
--- a/src/programs/SPH_MHD/SPH_analyzer_MHD.f90
+++ b/src/programs/SPH_MHD/SPH_analyzer_MHD.f90
@@ -41,7 +41,6 @@
       use material_property
       use sph_transforms_4_MHD
       use set_radius_func
-      use cal_sph_bc_fdm_matrix
       use const_radial_mat_4_sph
       use cal_rms_fields_by_sph
       use const_coriolis_sph
@@ -87,9 +86,6 @@
       if (iflag_debug.gt.0) write(*,*) 'const_2nd_fdm_matrices'
       call const_2nd_fdm_matrices
 !
-      if (iflag_debug.gt.0) write(*,*) 's_cal_sph_bc_fdm_matrices'
-      call s_cal_sph_bc_fdm_matrices
-!
       if (iflag_debug.gt.0) write(*,*) 'const_2nd_fdm_coefs'
       call const_2nd_fdm_coefs
 !
@@ -101,21 +97,20 @@
         call init_sum_coriolis_sph
       end if
 !
-! --------- set reference temperature
+! ---------------------------------
 !
-      call allocate_reft_rj_data
-      call s_set_ref_temp_sph_mhd
-!      call check_reference_temp(my_rank)
+      if(iflag_debug.gt.0) write(*,*)' set_material_property'
+      call set_material_property
 !
-! ---------------------------------
+!  -------------------------------
 !
-      if (iflag_debug.gt.0) write(*,*) 'init_sph_transform_MHD'
-      call init_sph_transform_MHD
+      if(iflag_debug.gt.0) write(*,*) 's_set_bc_sph_mhd'
+      call s_set_bc_sph_mhd
 !
 ! ---------------------------------
 !
-      if(iflag_debug.gt.0) write(*,*)' set_material_property'
-      call set_material_property
+      if (iflag_debug.gt.0) write(*,*) 'init_sph_transform_MHD'
+      call init_sph_transform_MHD
 !
 !  -------------------------------
 !
@@ -127,11 +122,6 @@
 !
 !  -------------------------------
 !
-      if(iflag_debug.gt.0) write(*,*) 's_set_bc_sph_mhd'
-      call s_set_bc_sph_mhd
-!
-!  -------------------------------
-!
       if(iflag_debug.gt.0) write(*,*)' s_const_radial_mat_4_sph'
       call s_const_radial_mat_4_sph
 !*
diff --git a/src/programs/data_utilities/INITIAL_FIELD/SPH_analyzer_const_initial.f90 b/src/programs/data_utilities/INITIAL_FIELD/SPH_analyzer_const_initial.f90
index a67bd9f..768fefb 100644
--- a/src/programs/data_utilities/INITIAL_FIELD/SPH_analyzer_const_initial.f90
+++ b/src/programs/data_utilities/INITIAL_FIELD/SPH_analyzer_const_initial.f90
@@ -39,7 +39,6 @@
       use material_property
       use sph_transforms_4_MHD
       use set_radius_func
-      use cal_sph_bc_fdm_matrix
       use const_radial_mat_4_sph
       use cal_rms_fields_by_sph
       use const_coriolis_sph
@@ -77,40 +76,6 @@
       call set_radius_rot_reft_dat_4_sph(depth_high_t, depth_low_t,     &
      &    high_temp, low_temp, angular)
 !
-!      if (iflag_debug.gt.0) write(*,*) 'const_2nd_fdm_matrices'
-!      call const_2nd_fdm_matrices
-!
-!      if (iflag_debug.gt.0) write(*,*) 's_cal_sph_bc_fdm_matrices'
-!      call s_cal_sph_bc_fdm_matrices
-!
-!      if (iflag_debug.gt.0) write(*,*) 'const_2nd_fdm_coefs'
-!      call const_2nd_fdm_coefs
-!
-!* -----  set integrals for coriolis term -----------------
-!*
-!      if(iflag_4_coriolis .gt. id_turn_OFF) then
-!        if ( iflag_debug.gt.0 ) write(*,*) 'init_sum_coriolis_sph'
-!        call init_sum_coriolis_sph
-!      end if
-!
-! --------- set reference temperature
-!
-!      call allocate_reft_rj_data
-!      call s_set_ref_temp_sph_mhd
-!      call check_reference_temp(my_rank)
-!
-! ---------------------------------
-!
-!      if (iflag_debug.gt.0) write(*,*) 'init_sph_transform_MHD'
-!      call init_sph_transform_MHD
-!
-! ---------------------------------
-!
-!      if(iflag_debug.gt.0) write(*,*)' set_material_property'
-!      call set_material_property
-!
-!  -------------------------------
-!
       if(iflag_debug.gt.0) write(*,*)' sph_initial_spectrum'
       call sph_initial_spectrum
 !
diff --git a/src/programs/data_utilities/SNAPSHOT_MHD/SPH_analyzer_d_bench.f90 b/src/programs/data_utilities/SNAPSHOT_MHD/SPH_analyzer_d_bench.f90
index 134c632..ed663b4 100644
--- a/src/programs/data_utilities/SNAPSHOT_MHD/SPH_analyzer_d_bench.f90
+++ b/src/programs/data_utilities/SNAPSHOT_MHD/SPH_analyzer_d_bench.f90
@@ -47,7 +47,6 @@
       use material_property
       use sph_transforms_4_MHD
       use set_radius_func
-      use cal_sph_bc_fdm_matrix
       use const_radial_mat_4_sph
       use cal_rms_fields_by_sph
       use const_coriolis_sph
@@ -85,9 +84,6 @@
       if (iflag_debug.gt.0) write(*,*) 'const_2nd_fdm_matrices'
       call const_2nd_fdm_matrices
 !
-      if (iflag_debug.gt.0) write(*,*) 's_cal_sph_bc_fdm_matrices'
-      call s_cal_sph_bc_fdm_matrices
-!
       if (iflag_debug.gt.0) write(*,*) 'const_2nd_fdm_coefs'
       call const_2nd_fdm_coefs
 !
@@ -98,17 +94,6 @@
         call init_sum_coriolis_sph
       end if
 !
-! --------- set reference temperature
-!
-      call allocate_reft_rj_data
-      call s_set_ref_temp_sph_mhd
-!      call check_reference_temp(my_rank)
-!
-! ---------------------------------
-!
-      if (iflag_debug.gt.0) write(*,*) 'init_sph_transform_MHD'
-      call init_sph_transform_MHD
-!
 ! ---------------------------------
 !
       if (iflag_debug.eq.1) write(*,*) 'set_material_property'
@@ -121,6 +106,11 @@
 !
 !  -------------------------------
 !
+      if (iflag_debug.gt.0) write(*,*) 'init_sph_transform_MHD'
+      call init_sph_transform_MHD
+!
+! ---------------------------------
+!
       if (iflag_debug.eq.1) write(*,*) 's_const_radial_mat_4_sph'
       call s_const_radial_mat_4_sph
 !
diff --git a/src/programs/data_utilities/SNAPSHOT_MHD/SPH_analyzer_snap.f90 b/src/programs/data_utilities/SNAPSHOT_MHD/SPH_analyzer_snap.f90
index 13cc4d7..aa2f0dd 100644
--- a/src/programs/data_utilities/SNAPSHOT_MHD/SPH_analyzer_snap.f90
+++ b/src/programs/data_utilities/SNAPSHOT_MHD/SPH_analyzer_snap.f90
@@ -39,7 +39,6 @@
       use material_property
       use sph_transforms_4_MHD
       use set_radius_func
-      use cal_sph_bc_fdm_matrix
       use const_radial_mat_4_sph
       use cal_rms_fields_by_sph
       use const_coriolis_sph
@@ -79,9 +78,6 @@
       if (iflag_debug.gt.0) write(*,*) 'const_2nd_fdm_matrices'
       call const_2nd_fdm_matrices
 !
-      if (iflag_debug.gt.0) write(*,*) 's_cal_sph_bc_fdm_matrices'
-      call s_cal_sph_bc_fdm_matrices
-!
       if (iflag_debug.gt.0) write(*,*) 'const_2nd_fdm_coefs'
       call const_2nd_fdm_coefs
 !
@@ -92,17 +88,6 @@
         call init_sum_coriolis_sph
       end if
 !
-! --------- set reference temperature
-!
-      call allocate_reft_rj_data
-      call s_set_ref_temp_sph_mhd
-!      call check_reference_temp(my_rank)
-!
-! ---------------------------------
-!
-      if (iflag_debug.gt.0) write(*,*) 'init_sph_transform_MHD'
-      call init_sph_transform_MHD
-!
 ! ---------------------------------
 !
       if (iflag_debug.eq.1) write(*,*) 'set_material_property'
@@ -115,6 +100,11 @@
 !
 !  -------------------------------
 !
+      if (iflag_debug.gt.0) write(*,*) 'init_sph_transform_MHD'
+      call init_sph_transform_MHD
+!
+! ---------------------------------
+!
       if (iflag_debug.eq.1) write(*,*) 's_const_radial_mat_4_sph'
       call s_const_radial_mat_4_sph
 !



More information about the CIG-COMMITS mailing list