20#include "scaleFElib.h"
26 use scale_const,
only: &
29 rplanet => const_radius
52 module procedure :: cubedspherecoordcnv_cs2localorthvec_alpha_0
53 module procedure :: cubedspherecoordcnv_cs2localorthvec_alpha_1
58 module procedure :: cubedspherecoordcnv_localorth2csvec_alpha_0
59 module procedure :: cubedspherecoordcnv_localorth2csvec_alpha_1
84 panelID, alpha, beta, gam, Np, & ! (in)
90 integer,
intent(in) :: panelid
91 integer,
intent(in) :: np
92 real(rp),
intent(in) :: alpha(np)
93 real(rp),
intent(in) :: beta (np)
94 real(rp),
intent(in) :: gam(np)
95 real(rp),
intent(out) :: lon(np)
96 real(rp),
intent(out) :: lat(np)
98 real(rp) :: cartpos(np,3)
99 real(rp) :: geogpos(np,3)
104 select case( panelid )
109 lon(p) = alpha(p) + 0.5_rp * pi * dble(panelid - 1)
110 lat(p) = atan( tan( beta(p) ) * cos( alpha(p) ) )
113 where( lon(:) < 0.0_rp )
114 lon(:) = lon(:) + 2.0_rp * pi
120 cartpos(:,1), cartpos(:,2), cartpos(:,3) )
128 lon(p) = geogpos(p,1)
129 lat(p) = geogpos(p,2)
132 where( alpha < 0.0_rp )
133 lon(:) = lon(:) + 2.0_rp * pi
138 log_error(
"CubedSphereCoordCnv_CS2LonLatPos",
'(a,i2,a)')
"panelID ", panelid,
" is invalid. Check!"
147 panelID, alpha, beta, gam, Np, & ! (in)
152 use scale_const,
only: &
156 integer,
intent(in) :: panelid
157 integer,
intent(in) :: np
158 real(rp),
intent(in) :: alpha(np)
159 real(rp),
intent(in) :: beta (np)
160 real(rp),
intent(in) :: gam(np)
161 real(dp),
intent(in) :: vecalpha(np)
162 real(dp),
intent(in) :: vecbeta (np)
163 real(rp),
intent(out) :: veclon(np)
164 real(rp),
intent(out) :: veclat(np)
165 real(rp),
intent(in),
optional :: lat(np)
168 real(rp) :: x ,y, del2
172 real(rp) :: cos_lat(np)
175 if (
present(lat))
then
178 cos_lat(p) = cos(lat(p))
182 select case( panelid )
184 if (.not.
present(lat))
then
187 cos_lat(p) = cos( atan( tan( beta(p) ) * cos( alpha(p) ) ) )
195 del2 = 1.0_rp + x**2 + y**2
196 radius = rplanet * gam(p)
198 veclon(p) = vecalpha(p) * cos_lat(p) * radius
199 veclat(p) = ( - x * y * vecalpha(p) + ( 1.0_rp + y**2 ) * vecbeta(p) ) &
200 * radius * sqrt( 1.0_rp + x**2 ) / del2
207 log_error(
"CubedSphereCoordCnv_CS2LonLatVec",
'(a,i2,a)')
"panelID ", panelid,
" is invalid. Check!"
211 select case( panelid )
217 del2 = 1.0_rp + x**2 + y**2
218 radius = s * rplanet * gam(p)
220 if (.not.
present(lat))
then
221 cos_lat(p) = cos( atan( sign(1.0_rp, s) / max( sqrt( x**2 + y**2 ), eps ) ) )
224 veclon(p) = (- y * ( 1.0_rp + x**2 ) * vecalpha(p) + x * ( 1.0_rp + y**2 ) * vecbeta(p) ) &
225 * radius / max( x**2 + y**2, eps ) * cos_lat(p)
226 veclat(p) = (- x * ( 1.0_rp + x**2 ) * vecalpha(p) - y * ( 1.0_rp + y**2 ) * vecbeta(p) ) &
227 * radius / ( del2 * ( max( sqrt( x**2 + y**2 ), eps ) ) )
236 panelID, lon, lat, Np, & ! (in)
241 integer,
intent(in) :: panelid
242 integer,
intent(in) :: np
243 real(rp),
intent(in) :: lon(np)
244 real(rp),
intent(in) :: lat(np)
245 real(rp),
intent(out) ::alpha(np)
246 real(rp),
intent(out) ::beta (np)
256 if ( panelid == 1 )
then
258 where (lon(:) >= 2.0_rp * pi - 0.25_rp * pi )
259 lon_(:) = lon(:) - 2.0_rp * pi
266 where (lon(:) < 0.0_rp )
267 lon_(:) = lon(:) + 2.0_rp * pi
275 alpha(p) = lon_(p) - 0.5_rp * pi * ( dble(panelid) - 1.0_rp )
276 beta(p) = atan( tan(lat(p)) / cos(alpha(p)) )
283 tan_lat = tan(lat(p))
284 alpha(p) = + atan( sin(lon(p)) / tan_lat )
285 beta(p) = - atan( cos(lon(p)) / tan_lat )
292 tan_lat = tan(lat(p))
293 alpha(p) = - atan( sin(lon(p)) / tan_lat )
294 beta(p) = - atan( cos(lon(p)) / tan_lat )
298 log_error(
"CubedSphereCoordCnv_LonLat2CSPos",
'(a,i2,a)')
"panelID ", panelid,
" is invalid. Check!"
309 panelID, alpha, beta, gam, Np, & ! (in)
316 integer,
intent(in) :: panelid
317 integer,
intent(in) :: np
318 real(rp),
intent(in) :: alpha(np)
319 real(rp),
intent(in) :: beta (np)
320 real(rp),
intent(in) :: gam(np)
321 real(dp),
intent(in) :: veclon(np)
322 real(dp),
intent(in) :: veclat(np)
323 real(rp),
intent(out) :: vecalpha(np)
324 real(rp),
intent(out) :: vecbeta (np)
325 real(rp),
intent(in),
optional :: lat(np)
328 real(rp) :: x ,y, del2
332 real(rp) :: cos_lat(np)
333 real(rp) :: veclon_ov_coslat
336 if (
present(lat))
then
339 cos_lat(p) = cos(lat(p))
343 select case( panelid )
345 if (.not.
present(lat))
then
348 cos_lat(p) = cos( atan( tan( beta(p) ) * cos( alpha(p) ) ) )
356 del2 = 1.0_rp + x**2 + y**2
357 radius = rplanet * gam(p)
358 veclon_ov_coslat = veclon(p) / cos_lat(p)
360 vecalpha(p) = veclon_ov_coslat / radius
361 vecbeta(p) = ( x * y * veclon_ov_coslat + del2 / sqrt( 1.0_rp + x**2 ) * veclat(p) ) &
362 / ( radius * (1.0_rp + y**2) )
369 log_error(
"CubedSphereCoordCnv_LonLat2CSVec",
'(a,i2,a)')
"panelID ", panelid,
" is invalid. Check!"
373 select case( panelid )
379 del2 = 1.0_rp + x**2 + y**2
380 radius = s * rplanet * gam(p)
382 if (.not.
present(lat))
then
383 cos_lat(p) = cos( atan( s / sqrt(max(x**2 + y**2, eps)) ) )
385 veclon_ov_coslat = veclon(p) / cos_lat(p)
387 vecalpha(p) = (- y * veclon_ov_coslat - del2 * x / sqrt( max(del2 - 1.0_rp,eps)) * veclat(p)) &
388 / ( radius * ( 1.0_rp + x**2 ) )
389 vecbeta(p) = ( x * veclon_ov_coslat - del2 * y / sqrt( max(del2 - 1.0_rp,eps)) * veclat(p)) &
390 / ( radius * ( 1.0_rp + y**2 ) )
399 panelID, alpha, beta, gam, Np, & ! (in)
403 integer,
intent(in) :: panelid
404 integer,
intent(in) :: np
405 real(rp),
intent(in) :: alpha(np)
406 real(rp),
intent(in) :: beta (np)
407 real(rp),
intent(in) :: gam(np)
408 real(rp),
intent(out) :: x(np)
409 real(rp),
intent(out) :: y(np)
410 real(rp),
intent(out) :: z(np)
413 real(rp) :: x1, x2, fac
423 fac = rplanet * gam(p) / sqrt( 1.0_rp + x1**2 + x2**2 )
433 fac = rplanet * gam(p) / sqrt( 1.0_rp + x1**2 + x2**2 )
443 fac = rplanet * gam(p) / sqrt( 1.0_rp + x1**2 + x2**2 )
453 fac = rplanet * gam(p) / sqrt( 1.0_rp + x1**2 + x2**2 )
463 fac = rplanet * gam(p) / sqrt( 1.0_rp + x1**2 + x2**2 )
473 fac = rplanet * gam(p) / sqrt( 1.0_rp + x1**2 + x2**2 )
479 log_error(
"CubedSphereCoordCnv_CS2CartPos",
'(a,i2,a)')
"panelID ", panelid,
" is invalid. Check!"
490 panelID, alpha, beta, gam, Np, & ! (in)
491 vec_x, vec_y, vec_z, &
496 integer,
intent(in) :: panelid
497 integer,
intent(in) :: np
498 real(rp),
intent(in) :: alpha(np)
499 real(rp),
intent(in) :: beta (np)
500 real(rp),
intent(in) :: gam(np)
501 real(dp),
intent(in) :: vec_x(np)
502 real(dp),
intent(in) :: vec_y(np)
503 real(dp),
intent(in) :: vec_z(np)
504 real(rp),
intent(out) :: vecalpha(np)
505 real(rp),
intent(out) :: vecbeta (np)
508 real(rp) :: x1, x2, fac
509 real(rp) :: r_sec2_alpha, r_sec2_beta
512 select case( panelid )
518 r_sec2_alpha = cos(alpha(p))**2
519 r_sec2_beta = cos(beta(p))**2
520 fac = sqrt( 1.0_rp + x1**2 + x2**2 ) / ( rplanet * gam(p) )
522 vecalpha(p) = fac * r_sec2_alpha * ( - x1 * vec_x(p) + vec_y(p) )
523 vecbeta(p) = fac * r_sec2_beta * ( - x2 * vec_x(p) + vec_z(p) )
530 r_sec2_alpha = cos(alpha(p))**2
531 r_sec2_beta = cos(beta(p))**2
532 fac = sqrt( 1.0_rp + x1**2 + x2**2 ) / ( rplanet * gam(p) )
534 vecalpha(p) = - fac * r_sec2_alpha * ( vec_x(p) + x1 * vec_y(p) )
535 vecbeta(p) = fac * r_sec2_beta * ( - x2 * vec_y(p) + vec_z(p) )
542 r_sec2_alpha = cos(alpha(p))**2
543 r_sec2_beta = cos(beta(p))**2
544 fac = sqrt( 1.0_rp + x1**2 + x2**2 ) / ( rplanet * gam(p) )
546 vecalpha(p) = fac * r_sec2_alpha * ( x1 * vec_x(p) - vec_y(p) )
547 vecbeta(p) = fac * r_sec2_beta * ( x2 * vec_x(p) + vec_z(p) )
554 r_sec2_alpha = cos(alpha(p))**2
555 r_sec2_beta = cos(beta(p))**2
556 fac = sqrt( 1.0_rp + x1**2 + x2**2 ) / ( rplanet * gam(p) )
558 vecalpha(p) = fac * r_sec2_alpha * ( vec_x(p) + x1 * vec_y(p) )
559 vecbeta(p) = fac * r_sec2_beta * ( x2 * vec_y(p) + vec_z(p) )
566 r_sec2_alpha = cos(alpha(p))**2
567 r_sec2_beta = cos(beta(p))**2
568 fac = sqrt( 1.0_rp + x1**2 + x2**2 ) / ( rplanet * gam(p) )
570 vecalpha(p) = fac * r_sec2_alpha * ( vec_y(p) - x1 * vec_z(p) )
571 vecbeta(p) = - fac * r_sec2_beta * ( vec_x(p) + x2 * vec_z(p) )
578 r_sec2_alpha = cos(alpha(p))**2
579 r_sec2_beta = cos(beta(p))**2
580 fac = sqrt( 1.0_rp + x1**2 + x2**2 ) / ( rplanet * gam(p) )
582 vecalpha(p) = fac * r_sec2_alpha * ( vec_y(p) + x1 * vec_z(p) )
583 vecbeta(p) = fac * r_sec2_beta * ( vec_x(p) + x2 * vec_z(p) )
586 log_error(
"CubedSphereCoordCnv_Cart2CSVec",
'(a,i2,a)')
"panelID ", panelid,
" is invalid. Check!"
594 subroutine cubedspherecoordcnv_cs2localorthvec_alpha_0( &
595 alpha, beta, radius, Np, & ! (in)
600 integer,
intent(in) :: Np
601 real(RP),
intent(in) :: alpha(Np)
602 real(RP),
intent(in) :: beta (Np)
603 real(RP),
intent(in) :: radius(Np)
604 real(RP),
intent(inout) :: VecOrth1(Np)
605 real(RP),
intent(inout) :: VecOrth2(Np)
608 real(RP) :: x1, x2, del
617 del = sqrt(1.0_rp + x1**2 + x2**2)
618 fac = radius(p) * sqrt(1.0_rp + x1**2) / del**2
621 vecorth1(p) = fac * del * tmp
622 vecorth2(p) = fac * ( - x1 * x2 * tmp + (1.0_rp + x2**2) * vecorth2(p) )
626 end subroutine cubedspherecoordcnv_cs2localorthvec_alpha_0
629 subroutine cubedspherecoordcnv_cs2localorthvec_alpha_1( &
630 alpha, beta, radius, Np, & ! (in)
636 integer,
intent(in) :: Np
637 real(RP),
intent(in) :: alpha(Np)
638 real(RP),
intent(in) :: beta (Np)
639 real(RP),
intent(in) :: radius(Np)
640 real(RP),
intent(in) :: VecAlpha(Np)
641 real(RP),
intent(in) :: VecBeta (Np)
642 real(RP),
intent(out) :: VecOrth1(Np)
643 real(RP),
intent(out) :: VecOrth2(Np)
648 vecorth1(:) = vecalpha(:)
649 vecorth2(:) = vecbeta(:)
652 call cubedspherecoordcnv_cs2localorthvec_alpha_0( &
653 alpha, beta, radius, np, &
657 end subroutine cubedspherecoordcnv_cs2localorthvec_alpha_1
660 subroutine cubedspherecoordcnv_localorth2csvec_alpha_0( &
661 alpha, beta, radius, Np, & ! (in)
666 integer,
intent(in) :: Np
667 real(RP),
intent(in) :: alpha(Np)
668 real(RP),
intent(in) :: beta (Np)
669 real(RP),
intent(in) :: radius(Np)
670 real(RP),
intent(inout) :: VecAlpha(Np)
671 real(RP),
intent(inout) :: VecBeta (Np)
674 real(RP) :: x1, x2, del
683 del = sqrt(1.0_rp + x1**2 + x2**2)
684 fac = del / ( radius(p) * ( 1.0_rp + x2**2 ) * sqrt( 1.0_rp + x1**2 ) )
687 vecalpha(p) = fac * ( 1.0_rp + x2**2 ) * tmp
688 vecbeta(p) = fac * ( x1 * x2 * tmp + del * vecbeta(p) )
692 end subroutine cubedspherecoordcnv_localorth2csvec_alpha_0
695 subroutine cubedspherecoordcnv_localorth2csvec_alpha_1( &
696 alpha, beta, radius, Np, & ! (in)
697 vecorth1, vecorth2, &
702 integer,
intent(in) :: Np
703 real(RP),
intent(in) :: alpha(Np)
704 real(RP),
intent(in) :: beta (Np)
705 real(RP),
intent(in) :: radius(Np)
706 real(RP),
intent(in) :: VecOrth1(Np)
707 real(RP),
intent(in) :: VecOrth2(Np)
708 real(RP),
intent(out) :: VecAlpha(Np)
709 real(RP),
intent(out) :: VecBeta (Np)
713 vecalpha(:) = vecorth1(:)
714 vecbeta(:) = vecorth2(:)
717 call cubedspherecoordcnv_localorth2csvec_alpha_0( &
718 alpha, beta, radius, np, &
722 end subroutine cubedspherecoordcnv_localorth2csvec_alpha_1
726 alpha, beta, Np, radius, & ! (in)
731 integer,
intent(in) :: np
732 real(rp),
intent(in) :: alpha(np)
733 real(rp),
intent(in) :: beta(np)
734 real(rp),
intent(in) :: radius
735 real(rp),
intent(out) :: g_ij(np,2,2)
736 real(rp),
intent(out) :: gij (np,2,2)
737 real(rp),
intent(out) :: gsqrt(np)
742 real(rp) :: g_ij_(2,2)
743 real(rp) :: gij_ (2,2)
746 real(rp) :: oneplusx2, oneplusy2
755 r2 = 1.0_rp + x**2 + y**2
756 oneplusx2 = 1.0_rp + x**2
757 oneplusy2 = 1.0_rp + y**2
759 fac = oneplusx2 * oneplusy2 * ( radius / r2 )**2
760 g_ij_(1,1) = fac * oneplusx2
761 g_ij_(1,2) = - fac * (x * y)
762 g_ij_(2,1) = - fac * (x * y)
763 g_ij_(2,2) = fac * oneplusy2
764 g_ij(p,:,:) = g_ij_(:,:)
766 gsqrt(p) = radius**2 * oneplusx2 * oneplusy2 / ( r2 * sqrt(r2) )
768 fac = 1.0_rp / gsqrt(p)**2
769 gij_(1,1) = fac * g_ij_(2,2)
770 gij_(1,2) = - fac * g_ij_(1,2)
771 gij_(2,1) = - fac * g_ij_(2,1)
772 gij_(2,2) = fac * g_ij_(1,1)
773 gij(p,:,:) = gij_(:,:)
module common / Coordinate conversion with a cubed-sphere
subroutine, public cubedspherecoordcnv_cs2lonlatvec(panelid, alpha, beta, gam, np, vecalpha, vecbeta, veclon, veclat, lat)
subroutine, public cubedspherecoordcnv_cs2lonlatpos(panelid, alpha, beta, gam, np, lon, lat)
subroutine, public cubedspherecoordcnv_lonlat2csvec(panelid, alpha, beta, gam, np, veclon, veclat, vecalpha, vecbeta, lat)
subroutine, public cubedspherecoordcnv_getmetric(alpha, beta, np, radius, g_ij, gij, gsqrt)
subroutine, public cubedspherecoordcnv_lonlat2cspos(panelid, lon, lat, np, alpha, beta)
subroutine, public cubedspherecoordcnv_cart2csvec(panelid, alpha, beta, gam, np, vec_x, vec_y, vec_z, vecalpha, vecbeta)
subroutine, public cubedspherecoordcnv_cs2cartpos(panelid, alpha, beta, gam, np, x, y, z)
module common / Coordinate conversion with a geographic coordinate
subroutine, public geographiccoordcnv_orth_to_geo_pos(orth_p, np, geo_p)